From a513f031397eb26b0f85678949ef964424487140 Mon Sep 17 00:00:00 2001 From: Peter Date: Tue, 4 Apr 2023 19:56:05 +0800 Subject: [PATCH 01/11] add FeynCalc.jl --- example/{FeynCalc.jl => FeynCalc_FermiK.jl} | 6 +- example/FeynCalc_mcmc.jl | 230 ++++++++++++++++++++ 2 files changed, 233 insertions(+), 3 deletions(-) rename example/{FeynCalc.jl => FeynCalc_FermiK.jl} (96%) create mode 100644 example/FeynCalc_mcmc.jl diff --git a/example/FeynCalc.jl b/example/FeynCalc_FermiK.jl similarity index 96% rename from example/FeynCalc.jl rename to example/FeynCalc_FermiK.jl index cde0cc3b..99f4cb93 100644 --- a/example/FeynCalc.jl +++ b/example/FeynCalc_FermiK.jl @@ -4,7 +4,7 @@ using FeynmanDiagram, MCIntegration, Lehmann using LinearAlgebra, Random, Printf using StaticArrays, AbstractTrees -Steps = 1e7 +Steps = 1e5 Base.@kwdef struct Para rs::Float64 = 1.0 beta::Float64 = 40.0 @@ -52,8 +52,8 @@ function integrand(vars, config) τ = @view [0.0;T][1:Order+1] extidx = Ext[1] q = para.extQ[extidx] - MomVar = hcat(q,k...) - FrontEnds.update(LoopPool,MomVar) + # MomVar = hcat(q,k...) + FrontEnds.update(LoopPool, hcat(q,k...)) for (i, lf) in enumerate(leafType) if (lf == 0) diff --git a/example/FeynCalc_mcmc.jl b/example/FeynCalc_mcmc.jl new file mode 100644 index 00000000..52375b01 --- /dev/null +++ b/example/FeynCalc_mcmc.jl @@ -0,0 +1,230 @@ +# This example demonstrated how to calculate the diagrams of free electrons without counterterms +# in various orders using the FeynmanDiagram and MCIntegration module. +using FeynmanDiagram, MCIntegration, Lehmann +using LinearAlgebra, Random, Printf +using StaticArrays, AbstractTrees + +Steps = 1e7 +Base.@kwdef struct Para + rs::Float64 = 1.0 + beta::Float64 = 40.0 + spin::Int = 2 + Qsize::Int = 6 + n::Int = 0 # external Matsubara frequency + dim::Int = 3 + me::Float64 = 0.5 + λ::Float64 = 1.0 + + kF::Float64 = (dim == 3) ? (9π / (2spin))^(1 / 3) / rs : sqrt(4 / spin) / rs + extQ::Vector{SVector{3,Float64}} = [@SVector [q, 0.0, 0.0] for q in LinRange(0.0 * kF, 2.5 * kF, Qsize)] + β::Float64 = beta / (kF^2 / 2me) +end + +function green(τ::T, ω::T, β::T) where {T} + #generate green function of fermion + if τ == T(0.0) + τ = -1e-10 + end + if τ > T(0.0) + return ω > T(0.0) ? + exp(-ω * τ) / (1 + exp(-ω * β)) : + exp(ω * (β - τ)) / (1 + exp(ω * β)) + else + return ω > T(0.0) ? + -exp(-ω * (τ + β)) / (1 + exp(-ω * β)) : + -exp(-ω * τ) / (1 + exp(ω * β)) + end +end + +function integrand(vars, config) + #generate the MC integrand function + K, T, Ext = vars + para = config.userdata[1] + Order = config.userdata[2] + leaf, leafType, leafτ_i, leafτ_o, leafMom = config.userdata[3] + graphfunc! = config.userdata[4] + LoopPool = config.userdata[5] + root = config.userdata[6] + + kF, β, me, λ = para.kF, para.β, para.me, para.λ + + k = @view K[1:Order] + τ = @view [0.0;T][1:Order+1] + extidx = Ext[1] + q = para.extQ[extidx] + # MomVar = hcat(q,k...) + FrontEnds.update(LoopPool, hcat(q,k...)) + + for (i, lf) in enumerate(leafType) + if (lf == 0) + continue + elseif (lf == 1) + τ_l = τ[leafτ_o[i]] - τ[leafτ_i[i]] + kq = FrontEnds.loop(LoopPool, leafMom[i]) + ω = (dot(kq, kq) - kF^2) / (2me) + # leaf[i] = Spectral.kernelFermiT(τ_l, ω, β) # green function of Fermion + leaf[i] = green(τ_l, ω, β) # green function of Fermion + else + kq = FrontEnds.loop(LoopPool, leafMom[i]) + leaf[i] = (8 * π) / (dot(kq, kq) + λ) + end + end + + graphfunc!(root, leaf) + return root .* ((1.0 / (2π)^3) .^ (1:Order)) +end + +function LeafInfor(FeynGraph::Graph, FermiLabel::LabelProduct, BoseLabel::LabelProduct) + #read information of each leaf from the generated graph and its LabelProduct, the information include type, loop momentum, imaginary time. + LeafType::Vector{Vector{Int}}=[[] for i in 1:length(FeynGraph.subgraphs)] + LeafInTau::Vector{Vector{Int}}=[[] for i in 1:length(FeynGraph.subgraphs)] + LeafOutTau::Vector{Vector{Int}}=[[] for i in 1:length(FeynGraph.subgraphs)] + LeafLoopMom::Vector{Vector{Int}}=[[] for i in 1:length(FeynGraph.subgraphs)] + Leaf::Vector{Vector{Float64}} = [[] for i in 1:length(FeynGraph.subgraphs)] + for (i, subg) in enumerate(FeynGraph.subgraphs) + for g in Leaves(subg) + if (g.type == FeynmanDiagram.ComputationalGraphs.Interaction) + push!(LeafType[i], 0) + In = Out = g.vertices[1][1].label + elseif (isfermionic(g.vertices[1])) + push!(LeafType[i], 1) + In, Out = g.vertices[1][1].label, g.vertices[2][1].label + else + push!(LeafType[i], 2) + In, Out = g.vertices[1][1].label, g.vertices[2][1].label + end + push!(Leaf[i], 1.0) + push!(LeafInTau[i], FermiLabel[In][1]) + push!(LeafOutTau[i], FermiLabel[Out][1]) + push!(LeafLoopMom[i], FrontEnds.linear_to_index(FermiLabel,In)[3]) #the label of LoopPool for each leaf + end + end + return Leaf, LeafType, LeafInTau, LeafOutTau, LeafLoopMom +end + +function integrand(idx, vars, config) #for the mcmc algorithm + K, T, Ext = vars + para = config.userdata[1] + # Order = idx + Order = config.userdata[2] + leaf, leafType, leafτ_i, leafτ_o, leafMom = config.userdata[3] + graphfunc! = config.userdata[4] + LoopPool = config.userdata[5] + root = config.userdata[6] + + kF, β, me, λ = para.kF, para.β, para.me, para.λ + + k = @view K[1:Order] + τ = @view [0.0;T][1:Order+1] + extidx = Ext[1] + q = para.extQ[extidx] + # MomVar = hcat(q,k...) + FrontEnds.update(LoopPool, hcat(q,k...)) + + for (i, lf) in enumerate(leafType[idx]) + if (lf == 0) + continue + elseif (lf == 1) + τ_l = τ[leafτ_o[idx][i]] - τ[leafτ_i[idx][i]] + kq = FrontEnds.loop(LoopPool, leafMom[idx][i]) + ω = (dot(kq, kq) - kF^2) / (2me) + # leaf[i] = Spectral.kernelFermiT(τ_l, ω, β) # green function of Fermion + leaf[idx][i] = green(τ_l, ω, β) # green function of Fermion + else + kq = FrontEnds.loop(LoopPool, leafMom[idx][i]) + leaf[idx][i] = (8 * π) / (dot(kq, kq) + λ) + end + end + graphfunc![idx](root, leaf[idx]) + return root[1] * (1.0 / (2π)^3)^idx +end + +function measure(vars, obs, weight, config) # for vegas and vegasmc algorithms + N = config.userdata[2] + Ext = vars[end] + for i in 1:N + obs[i][Ext[1]] += weight[i] + end +end + +function measure(idx, vars, obs, weight, config) # for the mcmc algorithm + Ext = vars[end] + obs[idx][Ext[1]] += weight +end + +@inline function green(str) + return "\u001b[32m$str\u001b[0m" +end + +function run(steps, MaxOrder::Int) + para = Para() + extQ, Qsize = para.extQ, para.Qsize + kF, β = para.kF, para.β + root = zeros(Float64, MaxOrder) + FeynGraph, FermiLabel, BoseLabel = PolarDiagrams(:charge, MaxOrder) + println(green("Diagrams with the largest order $MaxOrder has been read.")) + # SinGraph, FermiLabel, BoseLabel = PolarEachOrder(:charge, MaxOrder,0,0) + # println(green("Diagram with order $MaxOrder has been read.")) + # FeynGraph = Graph(SinGraph,factor=1.0) + #= + function PolarEachOrder(type::Symbol, order::Int, VerOrder::Int=0, SigmaOrder::Int=0; loopPool::Union{LoopPool,Nothing}=nothing, + # tau_labels::Union{Nothing,Vector{Int}}=nothing, GTypes::Union{Nothing,Vector{Int}}=nothing, VTypes::Union{Nothing,Vector{Int}}=nothing) + + Generates a `Graph`: the polarization diagrams with static interactions of a given order, where the actual order of diagrams equals to `order + VerOrder + 2 * SigmaOrder`. + =# + + # Ps = Compilers.to_julia_str([FeynGraph,], name="eval_graph!") + # Pexpr = Meta.parse(Ps) + # println(Pexpr) + # eval(Pexpr) + # funcGraph!(x, y) = Base.invokelatest(eval_graph!, x, y) + + funcGraph! = [Compilers.compile([FeynGraph.subgraphs[i],]) for i in 1:MaxOrder] #Compile graphs into a julia static function. + # println(green("Julia static function from Graph has been compiled.")) + + LoopPool = FermiLabel.labels[3] + + LeafStat = LeafInfor(FeynGraph, FermiLabel, BoseLabel) + # println(green("Leaf information has been extracted.")) + + T = Continuous(0.0, β; alpha=3.0, adapt=true) + # R = Continuous(0.0, 1.0; alpha=3.0, adapt=true) + # θ = Continuous(0.0, 1π; alpha=3.0, adapt=true) + # ϕ = Continuous(0.0, 2π; alpha=3.0, adapt=true) + K = MCIntegration.FermiK(3, kF, 0.2 * kF, 10.0 * kF) + Ext = Discrete(1, length(extQ); adapt=false) + + dof = [[Order, Order, 1] for Order in 1:MaxOrder] # degrees of freedom of the diagram + obs = [zeros(Float64, Qsize) for i in 1:MaxOrder] + + # dof = [[MaxOrder, MaxOrder, MaxOrder, MaxOrder, 1],] # degrees of freedom of the diagram + # obs = [zeros(Float64, Qsize),] + + println(green("Start computing integral:")) + result = integrate(integrand; measure=measure, userdata=(para, MaxOrder, LeafStat, funcGraph!, LoopPool, root), + var=(K, T, Ext), dof=dof, obs=obs, solver=:mcmc, + neval=steps, print=0, block=32) + + if isnothing(result) == false + avg, std = result.mean, result.stdev + + for o in 1:MaxOrder + println("Order:$o") + @printf("%10s %10s %10s \n", "q/kF", "avg", "err") + for (idx, q) in enumerate(extQ) + q = q[1] + if (MaxOrder==1) + @printf("%10.6f %10.6f ± %10.6f\n", q / kF, avg[idx], std[idx]) + else + @printf("%10.6f %10.6f ± %10.6f\n", q / kF, avg[o][idx], std[o][idx]) + end + end + end + report(result) + end +end + +# run(Steps, 1) +# run(Steps, 2) +run(Steps, 2) + From 112cb8f5fe2acc8161d3be19e4bdb2873fb89785 Mon Sep 17 00:00:00 2001 From: Peter Date: Wed, 5 Apr 2023 11:18:09 +0800 Subject: [PATCH 02/11] refactor FeynCalc_FermiL --- example/FeynCalc_mcmc.jl | 17 ++++++++++++----- 1 file changed, 12 insertions(+), 5 deletions(-) diff --git a/example/FeynCalc_mcmc.jl b/example/FeynCalc_mcmc.jl index 52375b01..28954146 100644 --- a/example/FeynCalc_mcmc.jl +++ b/example/FeynCalc_mcmc.jl @@ -4,7 +4,7 @@ using FeynmanDiagram, MCIntegration, Lehmann using LinearAlgebra, Random, Printf using StaticArrays, AbstractTrees -Steps = 1e7 +Steps = 1e6 Base.@kwdef struct Para rs::Float64 = 1.0 beta::Float64 = 40.0 @@ -111,13 +111,18 @@ function integrand(idx, vars, config) #for the mcmc algorithm graphfunc! = config.userdata[4] LoopPool = config.userdata[5] root = config.userdata[6] + τ = config.userdata[7] + ValK = config.userdata[8] kF, β, me, λ = para.kF, para.β, para.me, para.λ - k = @view K[1:Order] - τ = @view [0.0;T][1:Order+1] + τ[2:end] = @view T[1:Order] + extidx = Ext[1] q = para.extQ[extidx] + + ValK[:,1] = q + ValK[:,2:end] = @view K[1:Order] # MomVar = hcat(q,k...) FrontEnds.update(LoopPool, hcat(q,k...)) @@ -160,8 +165,10 @@ function run(steps, MaxOrder::Int) para = Para() extQ, Qsize = para.extQ, para.Qsize kF, β = para.kF, para.β - root = zeros(Float64, MaxOrder) + root = zeros(Float64, 1) FeynGraph, FermiLabel, BoseLabel = PolarDiagrams(:charge, MaxOrder) + Tau = zeros(Float64, MaxOrder+1) + KValue = zeros(Float64, para.dim, MaxOrder+1) println(green("Diagrams with the largest order $MaxOrder has been read.")) # SinGraph, FermiLabel, BoseLabel = PolarEachOrder(:charge, MaxOrder,0,0) # println(green("Diagram with order $MaxOrder has been read.")) @@ -201,7 +208,7 @@ function run(steps, MaxOrder::Int) # obs = [zeros(Float64, Qsize),] println(green("Start computing integral:")) - result = integrate(integrand; measure=measure, userdata=(para, MaxOrder, LeafStat, funcGraph!, LoopPool, root), + result = integrate(integrand; measure=measure, userdata=(para, MaxOrder, LeafStat, funcGraph!, LoopPool, root, Tau, KValue), var=(K, T, Ext), dof=dof, obs=obs, solver=:mcmc, neval=steps, print=0, block=32) From 19219fc7a7480f534b88244c0b2ddaae9d07f735 Mon Sep 17 00:00:00 2001 From: Lizhiyi Date: Sun, 25 Jun 2023 21:06:16 +0800 Subject: [PATCH 03/11] add SelfEnergygraph --- LocalPreferences.toml | 6 + .../groups_selfenergy/Polar2_0_0.diag | 32 + .../groups_selfenergy/Polar2_0_1.diag | 32 + .../groups_selfenergy/Polar2_0_2.diag | 32 + .../groups_selfenergy/Polar2_0_3.diag | 32 + .../groups_selfenergy/Polar2_0_4.diag | 32 + .../groups_selfenergy/Polar2_1_0.diag | 32 + .../groups_selfenergy/Polar2_1_1.diag | 32 + .../groups_selfenergy/Polar2_1_2.diag | 32 + .../groups_selfenergy/Polar2_1_3.diag | 32 + .../groups_selfenergy/Polar2_2_0.diag | 32 + .../groups_selfenergy/Polar2_2_1.diag | 32 + .../groups_selfenergy/Polar2_2_2.diag | 32 + .../groups_selfenergy/Polar2_3_0.diag | 32 + .../groups_selfenergy/Polar2_3_1.diag | 32 + .../groups_selfenergy/Polar2_4_0.diag | 32 + .../groups_selfenergy/Polar3_0_0.diag | 54 + .../groups_selfenergy/Polar3_0_1.diag | 138 + .../groups_selfenergy/Polar3_0_2.diag | 264 + .../groups_selfenergy/Polar3_0_3.diag | 432 ++ .../groups_selfenergy/Polar3_1_0.diag | 96 + .../groups_selfenergy/Polar3_1_1.diag | 264 + .../groups_selfenergy/Polar3_1_2.diag | 516 ++ .../groups_selfenergy/Polar3_2_0.diag | 138 + .../groups_selfenergy/Polar3_2_1.diag | 390 ++ .../groups_selfenergy/Polar3_3_0.diag | 180 + .../groups_selfenergy/Polar4_0_0.diag | 166 + .../groups_selfenergy/Polar4_0_1.diag | 782 +++ .../groups_selfenergy/Polar4_0_2.diag | 2322 +++++++ .../groups_selfenergy/Polar4_1_0.diag | 474 ++ .../groups_selfenergy/Polar4_1_1.diag | 2322 +++++++ .../groups_selfenergy/Polar4_2_0.diag | 936 +++ .../groups_selfenergy/Polar5_0_0.diag | 840 +++ .../groups_selfenergy/Polar5_0_1.diag | 5808 +++++++++++++++++ .../groups_selfenergy/Polar5_1_0.diag | 3324 ++++++++++ .../groups_selfenergy/Polar6_0_0.diag | 5316 +++++++++++++++ 36 files changed, 25248 insertions(+) create mode 100644 LocalPreferences.toml create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_1.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_2.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_3.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_4.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_1.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_2.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_3.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_1.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_2.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_3_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_3_1.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar2_4_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_1.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_2.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_3.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_1.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_2.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar3_2_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar3_2_1.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar3_3_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_1.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_2.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar4_1_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar4_1_1.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar4_2_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar5_0_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar5_0_1.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar5_1_0.diag create mode 100644 src/frontend/GV_diagrams/groups_selfenergy/Polar6_0_0.diag diff --git a/LocalPreferences.toml b/LocalPreferences.toml new file mode 100644 index 00000000..d88be561 --- /dev/null +++ b/LocalPreferences.toml @@ -0,0 +1,6 @@ +[MPIPreferences] +_format = "1.0" +abi = "OpenMPI" +binary = "system" +libmpi = "libmpi" +mpiexec = "mpiexec" diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_0.diag new file mode 100644 index 00000000..d8a6183e --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_0.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 0 0 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_1.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_1.diag new file mode 100644 index 00000000..52c24483 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_1.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 1 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 0 0 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_2.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_2.diag new file mode 100644 index 00000000..146063a6 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_2.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 2 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 0 0 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_3.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_3.diag new file mode 100644 index 00000000..5418a1ad --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_3.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 3 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 0 0 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_4.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_4.diag new file mode 100644 index 00000000..67768f7f --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_0_4.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 4 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 0 0 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_0.diag new file mode 100644 index 00000000..bc280b9c --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_0.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 1 1 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_1.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_1.diag new file mode 100644 index 00000000..833f2ca0 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_1.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 1 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 1 1 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_2.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_2.diag new file mode 100644 index 00000000..e4f17ef3 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_2.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 2 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 1 1 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_3.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_3.diag new file mode 100644 index 00000000..291e8370 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_1_3.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 3 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 1 1 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_0.diag new file mode 100644 index 00000000..8379a2d5 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_0.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 2 2 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_1.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_1.diag new file mode 100644 index 00000000..740a00ab --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_1.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 1 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 2 2 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_2.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_2.diag new file mode 100644 index 00000000..61012909 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_2_2.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 2 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 2 2 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_3_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_3_0.diag new file mode 100644 index 00000000..30aa10f9 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_3_0.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 3 3 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_3_1.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_3_1.diag new file mode 100644 index 00000000..a06a0a02 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_3_1.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 1 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 3 3 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar2_4_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_4_0.diag new file mode 100644 index 00000000..9956e53c --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar2_4_0.diag @@ -0,0 +1,32 @@ +#Type: Polarization +#DiagNum: 1 +#Order: 2 +#GNum: 4 +#Ver4Num: 1 +#LoopNum: 3 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 3 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 3 2 0 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 +# VertexBasis + 0 1 2 2 + 1 2 2 0 +# LoopBasis + 1 0 0 0 + 0 0 1 0 + 1 1 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 1 3 | +# WType(Direct,Exchange) + 4 4 | +# SpinFactor + 0 -2 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_0.diag new file mode 100644 index 00000000..5f452257 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_0.diag @@ -0,0 +1,54 @@ +#Type: Polarization +#DiagNum: 2 +#Order: 3 +#GNum: 6 +#Ver4Num: 2 +#LoopNum: 4 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 4 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_1.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_1.diag new file mode 100644 index 00000000..e627e89f --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_1.diag @@ -0,0 +1,138 @@ +#Type: Polarization +#DiagNum: 6 +#Order: 3 +#GNum: 6 +#Ver4Num: 2 +#LoopNum: 4 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 4 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_2.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_2.diag new file mode 100644 index 00000000..1f3c59ce --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_2.diag @@ -0,0 +1,264 @@ +#Type: Polarization +#DiagNum: 12 +#Order: 3 +#GNum: 6 +#Ver4Num: 2 +#LoopNum: 4 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 4 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 2 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 2 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 2 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 2 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 2 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_3.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_3.diag new file mode 100644 index 00000000..f1f189ba --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_0_3.diag @@ -0,0 +1,432 @@ +#Type: Polarization +#DiagNum: 20 +#Order: 3 +#GNum: 6 +#Ver4Num: 2 +#LoopNum: 4 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 4 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 3 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 3 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 2 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 2 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 2 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 2 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 3 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 3 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 2 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 1 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 2 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 2 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 2 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 3 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 2 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 1 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 2 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 2 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 2 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 3 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_0.diag new file mode 100644 index 00000000..93565abe --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_0.diag @@ -0,0 +1,96 @@ +#Type: Polarization +#DiagNum: 4 +#Order: 3 +#GNum: 6 +#Ver4Num: 2 +#LoopNum: 4 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 4 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_1.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_1.diag new file mode 100644 index 00000000..aa87e5b5 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_1.diag @@ -0,0 +1,264 @@ +#Type: Polarization +#DiagNum: 12 +#Order: 3 +#GNum: 6 +#Ver4Num: 2 +#LoopNum: 4 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 4 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_2.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_2.diag new file mode 100644 index 00000000..75ec1702 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_1_2.diag @@ -0,0 +1,516 @@ +#Type: Polarization +#DiagNum: 24 +#Order: 3 +#GNum: 6 +#Ver4Num: 2 +#LoopNum: 4 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 4 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 2 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 2 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 2 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 2 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 2 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 2 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 2 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 2 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 2 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 2 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar3_2_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_2_0.diag new file mode 100644 index 00000000..2a07a218 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_2_0.diag @@ -0,0 +1,138 @@ +#Type: Polarization +#DiagNum: 6 +#Order: 3 +#GNum: 6 +#Ver4Num: 2 +#LoopNum: 4 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 4 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 2 2 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 2 2 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 2 2 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 2 2 | 0 0 | +# SpinFactor + 4 -2 -2 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar3_2_1.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_2_1.diag new file mode 100644 index 00000000..c0a7acee --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_2_1.diag @@ -0,0 +1,390 @@ +#Type: Polarization +#DiagNum: 18 +#Order: 3 +#GNum: 6 +#Ver4Num: 2 +#LoopNum: 4 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 4 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 2 2 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 2 2 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 2 2 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 2 2 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 2 2 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 2 2 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 2 2 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 2 2 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 2 2 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 2 2 | 0 0 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 2 2 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 2 2 | 0 0 | +# SpinFactor + 4 -2 -2 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar3_3_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_3_0.diag new file mode 100644 index 00000000..df2319e2 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar3_3_0.diag @@ -0,0 +1,180 @@ +#Type: Polarization +#DiagNum: 8 +#Order: 3 +#GNum: 6 +#Ver4Num: 2 +#LoopNum: 4 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 4 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 0 0 | 3 3 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 0 0 | 3 3 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 1 1 | 2 2 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 1 1 | 2 2 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 2 2 | 1 1 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 2 2 | 1 1 | +# SpinFactor + 4 -2 -2 4 + +# Permutation + 1 2 0 4 3 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 2 0 3 2 3 +# LoopBasis + 1 0 0 0 0 0 + 1 1 1 0 0 0 + 0 0 0 1 1 0 + 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 5 5 | +# WType(Direct,Exchange) + 3 3 | 0 0 | +# SpinFactor + 0 0 0 2 + +# Permutation + 1 4 5 0 3 2 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 + 1 3 3 0 2 2 +# LoopBasis + 1 0 0 0 0 0 + 0 0 0 0 -1 1 + 1 1 0 1 1 0 + 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 2 5 | +# WType(Direct,Exchange) + 3 3 | 0 0 | +# SpinFactor + 4 -2 -2 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_0.diag new file mode 100644 index 00000000..c85ef1fc --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_0.diag @@ -0,0 +1,166 @@ +#Type: Polarization +#DiagNum: 7 +#Order: 4 +#GNum: 8 +#Ver4Num: 3 +#LoopNum: 5 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 5 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_1.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_1.diag new file mode 100644 index 00000000..8b2a1341 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_1.diag @@ -0,0 +1,782 @@ +#Type: Polarization +#DiagNum: 35 +#Order: 4 +#GNum: 8 +#Ver4Num: 3 +#LoopNum: 5 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 5 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 1 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 1 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_2.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_2.diag new file mode 100644 index 00000000..9c3760e7 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_0_2.diag @@ -0,0 +1,2322 @@ +#Type: Polarization +#DiagNum: 105 +#Order: 4 +#GNum: 8 +#Ver4Num: 3 +#LoopNum: 5 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 5 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 1 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 1 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 1 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 1 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 2 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 2 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 2 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 1 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 1 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 1 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 1 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 1 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 1 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 1 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 2 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 2 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 2 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 1 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 1 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 1 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 1 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 1 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 2 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 2 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 2 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 1 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 1 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 1 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 1 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 1 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 1 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 1 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 1 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 1 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 1 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 1 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 1 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 1 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 2 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 2 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 2 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 2 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 1 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 1 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 1 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 1 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 1 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 1 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 1 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 1 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 1 -2 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 1 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 1 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 1 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 1 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 2 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 2 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 2 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 2 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 2 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 2 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar4_1_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_1_0.diag new file mode 100644 index 00000000..51f0dba1 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_1_0.diag @@ -0,0 +1,474 @@ +#Type: Polarization +#DiagNum: 21 +#Order: 4 +#GNum: 8 +#Ver4Num: 3 +#LoopNum: 5 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 5 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar4_1_1.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_1_1.diag new file mode 100644 index 00000000..4c754f22 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_1_1.diag @@ -0,0 +1,2322 @@ +#Type: Polarization +#DiagNum: 105 +#Order: 4 +#GNum: 8 +#Ver4Num: 3 +#LoopNum: 5 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 5 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 1 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 1 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 1 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 1 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 1 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 1 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar4_2_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_2_0.diag new file mode 100644 index 00000000..4b18b2ef --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar4_2_0.diag @@ -0,0 +1,936 @@ +#Type: Polarization +#DiagNum: 42 +#Order: 4 +#GNum: 8 +#Ver4Num: 3 +#LoopNum: 5 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 5 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 2 2 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 2 2 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 2 2 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 2 2 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 2 2 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 2 2 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 2 2 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 1 1 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 2 2 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 2 2 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 2 2 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 0 0 | 2 2 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 0 0 | 2 2 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 0 0 | 2 2 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 0 0 | 2 2 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 1 1 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 1 1 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 1 1 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 1 1 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 2 4 3 6 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 2 3 2 4 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 + 0 0 0 1 1 0 0 0 + 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 1 7 | +# WType(Direct,Exchange) + 2 2 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -2 + +# Permutation + 1 4 6 0 3 2 5 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 3 4 0 2 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 2 2 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 0 2 5 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 0 2 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 0 + 1 1 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 7 7 | +# WType(Direct,Exchange) + 2 2 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 4 3 2 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 4 4 3 2 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 0 + 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 1 7 | +# WType(Direct,Exchange) + 2 2 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 2 0 6 3 4 5 7 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 0 4 2 3 3 4 +# LoopBasis + 1 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 + 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 7 7 | +# WType(Direct,Exchange) + 2 2 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 2 0 0 + +# Permutation + 1 3 6 7 0 2 5 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 4 0 2 3 3 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 + 1 1 1 0 1 0 0 1 + 1 1 1 0 1 0 1 0 + 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 3 7 | +# WType(Direct,Exchange) + 2 2 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 4 7 2 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 + 1 2 4 3 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 + 1 1 0 1 0 0 -1 1 + 1 1 1 0 0 0 0 1 + 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 4 7 | +# WType(Direct,Exchange) + 2 2 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar5_0_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar5_0_0.diag new file mode 100644 index 00000000..68dbf1eb --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar5_0_0.diag @@ -0,0 +1,840 @@ +#Type: Polarization +#DiagNum: 36 +#Order: 5 +#GNum: 10 +#Ver4Num: 4 +#LoopNum: 6 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 6 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar5_0_1.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar5_0_1.diag new file mode 100644 index 00000000..51deaf95 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar5_0_1.diag @@ -0,0 +1,5808 @@ +#Type: Polarization +#DiagNum: 252 +#Order: 5 +#GNum: 10 +#Ver4Num: 4 +#LoopNum: 6 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 6 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 0 -2 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 0 0 0 0 0 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 1 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 1 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 0 -2 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 0 0 0 0 0 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 0 0 1 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 1 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 0 -2 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 1 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 0 1 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 1 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 1 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 1 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 1 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 0 -2 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 0 0 0 0 1 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 1 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 1 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 1 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 1 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 1 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 1 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 1 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 0 -2 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 0 0 0 1 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 1 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 1 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 1 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 1 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 1 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 1 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 1 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 1 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 1 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 1 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 1 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 1 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 0 -2 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 0 0 1 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 -2 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 1 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 1 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 -2 1 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 1 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 0 1 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 1 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 1 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 1 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 1 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 1 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 1 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 1 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 0 1 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 1 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 1 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 1 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 0 1 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 0 1 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 0 1 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 1 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 1 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 0 1 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 0 1 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 1 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 1 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 0 1 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 0 1 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 1 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 1 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 1 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 1 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 1 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 1 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 1 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 1 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 1 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 1 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 1 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 1 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 1 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 1 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 1 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 1 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 1 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 1 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 1 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 1 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 1 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 1 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 1 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 1 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 1 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 1 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 1 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar5_1_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar5_1_0.diag new file mode 100644 index 00000000..134c82b1 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar5_1_0.diag @@ -0,0 +1,3324 @@ +#Type: Polarization +#DiagNum: 144 +#Order: 5 +#GNum: 10 +#Ver4Num: 4 +#LoopNum: 6 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 6 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 1 1 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 1 1 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 0 0 | 1 1 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 2 0 4 3 6 5 8 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 2 4 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 + +# Permutation + 1 4 6 0 3 2 5 8 7 9 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 2 6 4 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 6 4 3 2 5 8 7 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 + +# Permutation + 1 9 2 6 3 4 5 8 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 3 3 5 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 0 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 3 5 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 + +# Permutation + 1 6 2 4 8 0 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 2 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 0 4 8 6 5 3 7 9 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 3 5 4 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 + +# Permutation + 1 2 6 8 3 0 5 4 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 2 0 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 4 6 8 3 2 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 8 3 2 5 4 7 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 5 2 2 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 1 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 1 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 8 3 2 5 4 7 9 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 5 2 2 3 3 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 1 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 6 0 4 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 0 3 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 9 6 4 8 2 5 3 7 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 5 2 3 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 3 6 4 8 2 5 0 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 2 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 2 6 4 8 0 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 5 0 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 + 0 0 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 6 0 8 2 5 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 + 1 1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 5 6 4 8 2 0 3 7 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 3 5 2 0 2 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 + +# Permutation + 1 4 2 6 3 8 5 0 7 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 2 4 2 5 3 0 4 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 5 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 2 6 3 8 5 4 7 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 2 4 2 5 3 3 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 1 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 -4 0 -4 0 2 + +# Permutation + 1 9 6 4 3 2 7 8 5 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 2 2 4 5 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 1 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 5 9 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 3 2 2 0 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 9 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 0 4 2 3 4 5 3 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 9 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 9 8 7 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 3 0 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 6 0 3 2 9 8 7 5 +# SymFactor +-0.25 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 2 2 5 5 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 6 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 + +# Permutation + 1 4 9 8 3 2 5 0 7 6 +# SymFactor +0.125 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 5 5 2 2 3 0 4 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 + 0 0 0 1 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 1 -1 + 0 0 1 -1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 8 7 | 3 8 2 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 + +# Permutation + 1 8 6 0 3 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 0 2 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 3 6 8 0 2 9 4 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 2 4 5 0 2 5 3 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 1 1 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 4 6 8 3 2 9 0 7 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 5 2 2 5 0 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 + 0 0 1 0 1 0 0 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 7 6 8 3 2 9 4 0 5 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 4 4 5 2 2 5 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 +-1 -1 1 0 1 0 0 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 6 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 + +# Permutation + 1 8 6 4 0 2 9 3 7 5 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 5 2 4 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 + 0 0 0 1 0 0 0 1 1 -1 + 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 6 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 + +# Permutation + 1 8 6 4 0 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 5 4 3 0 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 7 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + +# Permutation + 1 4 6 0 8 2 5 9 7 3 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 + 1 3 4 0 5 2 3 5 4 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 7 9 | +# WType(Direct,Exchange) + 1 1 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 + diff --git a/src/frontend/GV_diagrams/groups_selfenergy/Polar6_0_0.diag b/src/frontend/GV_diagrams/groups_selfenergy/Polar6_0_0.diag new file mode 100644 index 00000000..b4418521 --- /dev/null +++ b/src/frontend/GV_diagrams/groups_selfenergy/Polar6_0_0.diag @@ -0,0 +1,5316 @@ +#Type: Polarization +#DiagNum: 221 +#Order: 6 +#GNum: 12 +#Ver4Num: 5 +#LoopNum: 7 +#ExtLoopIndex: 0 +#DummyLoopIndex: +#TauNum: 7 +#ExtTauIndex: 0 1 +#DummyTauIndex: + +# Permutation + 1 11 2 4 3 6 5 8 7 10 9 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 3 2 4 3 5 4 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 5 6 8 7 | 7 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -2 + +# Permutation + 1 11 6 4 3 2 5 8 7 10 9 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 2 2 3 5 4 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 7 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -4 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 -4 + +# Permutation + 1 3 6 4 0 2 5 8 7 10 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 0 2 3 5 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 0 0 + 1 1 1 0 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 7 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -4 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 -4 + +# Permutation + 1 4 6 0 3 2 5 8 7 10 9 11 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 2 2 3 5 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 7 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 -4 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 -4 + +# Permutation + 1 11 2 6 3 4 5 8 7 10 9 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 4 2 3 3 5 4 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 5 8 7 10 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 4 2 0 3 5 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 6 5 | 3 6 8 7 | 7 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 5 8 7 10 9 11 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 4 2 3 3 5 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 6 5 | 3 6 8 7 | 7 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 0 + +# Permutation + 1 5 2 4 8 6 0 3 7 10 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 3 5 4 0 2 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 1 0 0 -1 1 0 0 0 0 + 1 1 0 0 0 1 1 0 0 0 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 1 5 | 5 6 8 7 | 4 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 + +# Permutation + 1 6 2 4 8 0 5 3 7 10 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 3 5 0 3 2 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 1 1 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 + +# Permutation + 1 2 0 4 8 6 5 3 7 10 9 11 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 3 5 4 3 2 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 + +# Permutation + 1 11 2 4 8 6 5 3 7 10 9 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 3 5 4 3 2 4 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 5 6 8 7 | 4 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 + +# Permutation + 1 2 0 4 3 8 5 6 7 10 9 11 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 3 2 5 3 4 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 1 0 0 0 0 + 0 0 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 6 5 | 7 6 8 7 | 5 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 0 0 0 0 + +# Permutation + 1 11 2 4 3 8 5 6 7 10 9 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 3 2 5 3 4 4 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 1 0 0 0 0 + 0 0 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 7 6 8 7 | 5 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 0 0 0 0 + +# Permutation + 1 6 2 4 3 8 5 0 7 10 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 3 2 5 3 0 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 1 1 0 0 0 0 0 1 0 0 0 0 + 0 0 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 3 4 6 5 | 1 6 8 7 | 5 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 0 0 0 0 + +# Permutation + 1 2 6 8 3 0 5 4 7 10 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 5 2 0 3 3 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -2 + +# Permutation + 1 11 6 8 3 2 5 4 7 10 9 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 5 2 2 3 3 4 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 8 7 | 3 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -2 + +# Permutation + 1 6 0 8 3 2 5 4 7 10 9 11 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 5 2 2 3 3 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 0 0 + 1 1 1 0 1 0 1 0 0 0 0 0 +-1 -1 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -2 + +# Permutation + 1 5 6 8 3 2 0 4 7 10 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 5 2 2 0 3 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 1 1 1 0 1 0 1 0 0 0 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 1 5 | 2 6 8 7 | 3 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -2 + +# Permutation + 1 4 6 0 8 2 5 3 7 10 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 5 2 3 2 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 0 0 + 1 1 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 8 7 | 4 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -8 + +# Permutation + 1 3 6 4 8 2 5 0 7 10 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 2 3 0 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 0 0 + 1 1 0 1 0 0 -1 1 0 0 0 0 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -8 + +# Permutation + 1 11 6 4 8 2 5 3 7 10 9 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 2 3 2 4 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -8 + +# Permutation + 1 5 6 4 8 2 0 3 7 10 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 3 5 2 0 2 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 0 0 +-1 -1 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -8 + +# Permutation + 1 2 6 4 8 0 5 3 7 10 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 0 3 2 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -8 + +# Permutation + 1 6 0 4 8 2 5 3 7 10 9 11 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 3 5 2 3 2 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 -2 0 0 0 -2 0 0 0 4 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -8 + +# Permutation + 1 5 2 6 3 8 0 4 7 10 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 4 2 5 0 3 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 1 0 1 0 0 0 0 0 + 1 1 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 1 5 | 3 6 8 7 | 5 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -2 + +# Permutation + 1 11 2 6 3 8 5 4 7 10 9 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 4 2 5 3 3 4 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -2 + +# Permutation + 1 2 0 6 3 8 5 4 7 10 9 11 +# SymFactor +-0.5 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 4 2 5 3 3 4 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 3 6 8 7 | 5 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 4 0 0 0 4 0 0 0 -2 + +# Permutation + 1 7 6 4 3 2 0 8 5 10 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 3 2 2 0 5 3 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 0 0 + 1 1 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 1 7 | 7 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 4 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 5 10 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 0 2 4 5 3 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 4 0 0 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 5 10 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 2 2 4 5 3 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 8 5 | 2 6 6 7 | 7 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 4 0 0 0 0 + +# Permutation + 1 11 6 4 3 2 7 8 5 10 9 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 2 2 4 5 3 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 8 5 | 2 6 6 7 | 7 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 4 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 4 0 0 0 0 + +# Permutation + 1 7 2 6 3 4 0 8 5 10 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 4 2 3 0 5 3 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 0 0 + 1 1 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 8 5 | 3 6 1 7 | 7 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 0 0 0 0 0 + +# Permutation + 1 11 2 6 3 4 7 8 5 10 9 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 4 2 3 4 5 3 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 0 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 7 8 5 10 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 4 2 0 4 5 3 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 8 5 | 3 6 6 7 | 7 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 0 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 7 8 5 10 9 11 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 4 2 3 4 5 3 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 8 5 | 3 6 6 7 | 7 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 0 0 0 0 0 + +# Permutation + 1 2 0 6 7 8 5 4 3 10 9 11 +# SymFactor +0.5 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 4 4 5 3 3 2 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 0 1 1 0 1 0 0 0 + 0 0 0 0 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 8 3 | 7 4 6 5 | 3 6 4 7 | 5 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 + +# Permutation + 1 4 2 6 7 8 5 0 3 10 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 4 4 5 3 0 2 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 0 1 1 0 1 0 0 0 + 0 0 0 0 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 8 3 | 1 4 6 5 | 3 6 4 7 | 5 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 + +# Permutation + 1 11 2 6 7 8 5 4 3 10 9 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 4 4 5 3 3 2 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 0 1 1 0 1 0 0 0 + 0 0 0 0 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 8 3 | 7 4 6 5 | 3 6 4 7 | 5 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 + +# Permutation + 1 7 2 6 0 8 5 4 3 10 9 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 4 0 5 3 3 2 6 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 0 1 1 0 1 0 0 0 + 1 1 0 0 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 8 3 | 7 4 6 5 | 3 6 1 7 | 5 8 10 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 + +# Permutation + 1 7 6 4 3 2 10 8 0 5 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 3 2 2 6 5 0 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 +-1 -1 1 0 1 0 0 0 -1 1 0 0 + 1 1 0 0 0 0 0 1 1 0 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 9 5 | 2 6 1 7 | 7 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -8 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 11 6 4 3 2 10 8 7 5 9 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 2 2 6 5 4 3 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 9 5 | 2 6 8 7 | 7 8 10 9 | 6 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -8 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 4 6 0 3 2 10 8 7 5 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 2 2 6 5 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 7 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -8 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 2 6 4 3 0 10 8 7 5 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 2 0 6 5 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 3 4 9 5 | 2 6 8 7 | 7 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -8 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 8 6 4 3 2 10 0 7 5 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 2 2 6 0 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 1 1 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 9 5 | 2 6 8 7 | 1 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -8 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 4 6 0 3 2 5 10 7 8 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 2 2 3 6 4 5 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 8 7 | 9 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 4 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 4 0 0 + +# Permutation + 1 3 6 4 0 2 5 10 7 8 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 0 2 3 6 4 5 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 0 0 + 1 1 1 0 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 9 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 4 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 4 0 0 + +# Permutation + 1 8 6 4 3 2 5 10 7 0 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 2 2 3 6 4 0 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 1 1 0 0 0 0 0 0 0 1 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 1 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 4 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 4 0 0 + +# Permutation + 1 11 6 4 3 2 5 10 7 8 9 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 2 2 3 6 4 5 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 8 7 | 9 8 10 9 | 7 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 4 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 4 0 0 + +# Permutation + 1 7 2 6 3 4 10 8 0 5 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 4 2 3 6 5 0 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 0 0 +-1 -1 0 1 1 0 0 0 -1 1 0 0 + 1 1 0 0 0 0 0 1 1 0 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 9 5 | 3 6 1 7 | 7 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 0 0 0 0 0 0 0 + +# Permutation + 1 2 0 6 3 4 10 8 7 5 9 11 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 4 2 3 6 5 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 5 4 9 5 | 3 6 8 7 | 7 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 0 0 0 0 0 0 0 + +# Permutation + 1 11 2 6 3 4 10 8 7 5 9 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 4 2 3 6 5 4 3 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 9 5 | 3 6 8 7 | 7 8 10 9 | 6 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 0 0 0 0 0 0 0 + +# Permutation + 1 8 2 6 3 4 10 0 7 5 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 2 4 2 3 6 0 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 -1 1 0 0 + 1 1 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 9 5 | 3 6 8 7 | 1 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 0 0 0 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 10 8 7 5 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 4 2 0 6 5 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 9 5 | 3 6 8 7 | 7 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 0 0 0 0 0 0 0 + +# Permutation + 1 11 2 6 3 4 5 10 7 8 9 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 4 2 3 3 6 4 5 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 9 8 10 9 | 7 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 0 0 0 + +# Permutation + 1 8 2 6 3 4 5 10 7 0 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 2 4 2 3 3 6 4 0 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 1 0 0 0 0 0 + 1 1 0 0 0 0 0 0 0 1 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 5 4 6 5 | 3 6 8 7 | 1 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -2 0 0 0 0 0 0 0 0 0 0 + +# Permutation + 1 5 2 4 8 10 0 3 7 6 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 3 5 6 0 2 4 4 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 1 0 0 -1 1 0 0 0 0 + 1 1 0 0 1 0 1 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 1 5 | 9 6 8 7 | 4 8 10 9 | 5 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 11 2 4 8 10 5 3 7 6 9 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 3 5 6 3 2 4 4 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 9 6 8 7 | 4 8 10 9 | 5 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 2 0 4 8 10 5 3 7 6 9 11 +# SymFactor +-0.5 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 3 5 6 3 2 4 4 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 9 6 8 7 | 4 8 10 9 | 5 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 8 2 4 0 10 5 3 7 6 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 2 3 0 6 3 2 4 4 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 1 1 0 0 1 0 1 0 0 1 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 9 6 8 7 | 1 8 10 9 | 5 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 6 2 4 8 10 5 3 7 0 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 3 5 6 3 2 4 0 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 1 1 0 0 1 0 1 0 0 1 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 6 5 | 1 6 8 7 | 4 8 10 9 | 5 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 7 2 4 8 6 10 3 0 5 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 3 5 4 6 2 0 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 1 1 0 1 0 0 0 1 1 -1 0 0 +-1 -1 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 9 5 | 5 6 1 7 | 4 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 -2 0 4 0 4 0 -8 + +# Permutation + 1 2 0 4 8 6 10 3 7 5 9 11 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 3 5 4 6 2 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 0 1 1 -1 0 0 + 0 0 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 9 5 | 5 6 8 7 | 4 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 -2 0 4 0 4 0 -8 + +# Permutation + 1 8 2 4 0 6 10 3 7 5 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 2 3 0 4 6 2 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 0 1 1 -1 0 0 + 0 0 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 7 3 | 3 4 9 5 | 5 6 8 7 | 1 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 -2 0 4 0 -2 0 4 0 4 0 -8 + +# Permutation + 1 5 2 4 8 6 0 10 7 3 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 3 5 4 0 6 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 1 0 0 -1 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 9 3 | 3 4 1 5 | 5 6 8 7 | 4 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 8 2 4 0 6 5 10 7 3 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 2 3 0 4 3 6 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 9 3 | 3 4 6 5 | 5 6 8 7 | 1 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 2 0 4 8 6 5 10 7 3 9 11 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 3 5 4 3 6 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 9 3 | 3 4 6 5 | 5 6 8 7 | 4 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 11 2 4 8 6 5 10 7 3 9 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 3 5 4 3 6 4 2 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 9 3 | 3 4 6 5 | 5 6 8 7 | 4 8 10 9 | 7 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 7 2 4 8 6 5 10 0 3 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 3 5 4 3 6 0 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 1 0 0 -1 0 -1 1 0 0 + 0 0 0 0 0 1 1 0 0 0 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 + 1 1 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 9 3 | 3 4 6 5 | 5 6 1 7 | 4 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 6 2 4 8 0 5 10 7 3 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 3 5 0 3 6 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 -1 0 -1 1 0 0 + 1 1 0 0 0 1 1 0 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 9 3 | 3 4 6 5 | 1 6 8 7 | 4 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 8 2 4 10 0 5 6 7 3 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 2 3 6 0 3 4 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 1 1 0 1 0 1 0 0 0 1 0 0 + 0 0 0 0 0 0 0 1 0 0 0 0 + 1 1 0 0 0 1 1 0 1 0 0 0 +-1 -1 0 0 1 -1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 9 3 | 3 4 6 5 | 7 6 8 7 | 1 8 10 9 | 4 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 0 0 0 0 -2 0 4 0 0 0 0 + +# Permutation + 1 11 2 4 10 8 5 6 7 3 9 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 3 6 5 3 4 4 2 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 1 0 0 0 1 0 0 + 0 0 0 0 0 0 0 1 0 0 0 0 + 0 0 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 1 -1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 9 3 | 3 4 6 5 | 7 6 8 7 | 5 8 10 9 | 4 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 0 0 0 0 -2 0 4 0 0 0 0 + +# Permutation + 1 6 2 4 10 8 5 0 7 3 9 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 3 6 5 3 0 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 1 0 0 0 1 0 0 + 1 1 0 0 0 0 0 1 0 0 0 0 + 0 0 0 0 0 1 1 0 1 0 0 0 + 0 0 0 0 1 -1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 9 3 | 3 4 6 5 | 1 6 8 7 | 5 8 10 9 | 4 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -2 0 0 0 0 0 -2 0 4 0 0 0 0 + +# Permutation + 1 5 10 8 3 2 0 4 7 6 9 11 +# SymFactor +0.25 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 6 5 2 2 0 3 4 4 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 1 0 1 0 0 + 1 1 0 1 1 0 1 0 0 1 0 0 + 0 0 0 0 0 0 0 0 1 -1 0 0 + 0 0 1 -1 0 0 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 1 5 | 9 6 8 7 | 3 8 10 9 | 2 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 11 10 8 3 2 5 4 7 6 9 0 +# SymFactor +0.125 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 6 5 2 2 3 3 4 4 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 1 0 1 0 0 + 0 0 0 1 1 0 1 0 0 1 0 0 + 0 0 0 0 0 0 0 0 1 -1 0 0 + 0 0 1 -1 0 0 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 9 6 8 7 | 3 8 10 9 | 2 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 10 8 0 2 5 4 7 6 9 11 +# SymFactor +0.25 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 6 5 0 2 3 3 4 4 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 0 0 + 1 1 0 1 1 0 1 0 0 1 0 0 + 0 0 0 0 0 0 0 0 1 -1 0 0 + 0 0 1 -1 0 0 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 9 6 8 7 | 3 8 10 9 | 2 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 8 10 0 3 2 5 4 7 6 9 11 +# SymFactor +0.125 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 6 0 2 2 3 3 4 4 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 0 0 + 1 1 0 1 1 0 1 0 0 1 0 0 + 0 0 0 0 0 0 0 0 1 -1 0 0 +-1 -1 1 -1 0 0 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 9 6 8 7 | 1 8 10 9 | 2 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 6 10 8 3 2 5 4 7 0 9 11 +# SymFactor +0.25 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 6 5 2 2 3 3 4 0 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 0 0 + 1 1 0 1 1 0 1 0 0 1 0 0 +-1 -1 0 0 0 0 0 0 1 -1 0 0 + 0 0 1 -1 0 0 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 8 7 | 3 8 10 9 | 2 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 5 6 8 3 2 10 4 7 0 9 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 5 2 2 6 3 4 0 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 1 5 | 2 6 8 7 | 3 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 8 0 2 10 4 7 5 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 5 0 2 6 3 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 9 5 | 2 6 8 7 | 3 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 11 6 8 3 2 10 4 7 5 9 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 5 2 2 6 3 4 3 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 3 8 10 9 | 6 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 7 6 8 3 2 10 4 0 5 9 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 5 2 2 6 3 0 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 +-1 -1 1 0 1 0 0 0 -1 1 0 0 + 1 1 -1 1 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 6 0 8 3 2 10 4 7 5 9 11 +# SymFactor +0.5 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 5 2 2 6 3 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 1 0 0 +-1 -1 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 1 6 8 7 | 3 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 4 6 8 3 2 10 0 7 5 9 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 5 2 2 6 0 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 8 7 | 3 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 8 6 0 3 2 10 4 7 5 9 11 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 0 2 2 6 3 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 1 1 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 8 7 | 1 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 2 0 -4 + +# Permutation + 1 3 6 4 8 10 5 0 7 2 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 6 3 0 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 1 0 1 -1 0 1 0 0 + 1 1 0 1 0 0 -1 1 0 0 0 0 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 10 9 | 5 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 8 0 -4 + +# Permutation + 1 2 6 4 8 10 5 3 7 0 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 6 3 2 4 0 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 1 0 1 -1 0 1 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 10 9 | 5 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 8 0 -4 + +# Permutation + 1 8 6 4 0 10 5 3 7 2 9 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 0 6 3 2 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 1 0 1 -1 0 1 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 7 3 | 3 4 6 5 | 2 6 8 7 | 1 8 10 9 | 5 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 8 0 -4 + +# Permutation + 1 11 6 4 8 10 5 3 7 2 9 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 6 3 2 4 2 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 1 0 1 -1 0 1 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 7 3 | 3 4 6 5 | 2 6 8 7 | 4 8 10 9 | 5 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 8 0 -4 + +# Permutation + 1 5 6 4 8 10 0 3 7 2 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 3 5 6 0 2 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 1 0 1 -1 0 1 0 0 +-1 -1 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 10 9 | 5 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 8 0 -4 0 2 0 8 0 -4 + +# Permutation + 1 6 0 4 8 2 10 3 7 5 9 11 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 3 5 2 6 2 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 0 0 + 0 0 0 1 0 0 0 1 1 -1 0 0 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 1 6 8 7 | 4 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 8 0 8 0 -16 + +# Permutation + 1 5 6 4 8 2 10 3 7 0 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 3 5 2 6 2 4 0 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 -1 -1 1 0 0 +-1 -1 0 1 0 0 0 1 1 -1 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 1 1 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 8 7 | 4 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 8 0 8 0 -16 + +# Permutation + 1 7 6 4 8 2 10 3 0 5 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 3 5 2 6 2 0 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 0 -1 -1 1 0 0 + 1 1 0 1 0 0 0 1 1 -1 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 1 7 | 4 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 8 0 8 0 -16 + +# Permutation + 1 8 6 4 0 2 10 3 7 5 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 0 2 6 2 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 0 0 + 0 0 0 1 0 0 0 1 1 -1 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 1 1 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 1 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 8 0 8 0 -16 + +# Permutation + 1 4 6 0 8 2 10 3 7 5 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 5 2 6 2 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 0 0 + 1 1 0 1 0 0 0 1 1 -1 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 9 5 | 2 6 8 7 | 4 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 8 0 8 0 -16 + +# Permutation + 1 11 6 4 8 2 10 3 7 5 9 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 2 6 2 4 3 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 1 0 0 + 0 0 0 1 0 0 0 1 1 -1 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 9 5 | 2 6 8 7 | 4 8 10 9 | 6 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 8 0 8 0 -16 + +# Permutation + 1 3 6 4 8 2 10 0 7 5 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 2 6 0 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 0 -1 -1 1 0 0 + 1 1 0 1 0 0 0 1 1 -1 0 0 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 9 5 | 2 6 8 7 | 4 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 8 0 8 0 -16 + +# Permutation + 1 2 6 4 8 0 10 3 7 5 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 0 6 2 4 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 -1 -1 1 0 0 + 0 0 0 1 0 0 0 1 1 -1 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 9 5 | 2 6 8 7 | 4 8 10 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 2 0 -4 0 -4 0 8 0 -4 0 8 0 8 0 -16 + +# Permutation + 1 5 6 4 8 2 0 10 7 3 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 3 5 2 0 6 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 0 1 -1 0 0 +-1 -1 0 1 0 0 -1 0 -1 1 0 0 + 0 0 1 0 0 0 0 0 -1 1 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 1 5 | 2 6 8 7 | 4 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 8 0 8 0 -4 + +# Permutation + 1 6 0 4 8 2 5 10 7 3 9 11 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 3 5 2 3 6 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 0 0 + 0 0 0 1 0 0 -1 0 -1 1 0 0 + 1 1 1 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 1 6 8 7 | 4 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 8 0 8 0 -4 + +# Permutation + 1 4 6 0 8 2 5 10 7 3 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 5 2 3 6 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 0 0 + 1 1 0 1 0 0 -1 0 -1 1 0 0 + 0 0 1 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 6 5 | 2 6 8 7 | 4 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 8 0 8 0 -4 + +# Permutation + 1 7 6 4 8 2 5 10 0 3 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 3 5 2 3 6 0 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 0 1 -1 0 0 +-1 -1 0 1 0 0 -1 0 -1 1 0 0 +-1 -1 1 0 0 0 0 0 -1 1 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 + 1 1 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 1 7 | 4 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 8 0 8 0 -4 + +# Permutation + 1 3 6 4 8 2 5 10 7 0 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 2 3 6 4 0 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 0 1 -1 0 0 + 1 1 0 1 0 0 -1 0 -1 1 0 0 + 1 1 1 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 8 0 8 0 -4 + +# Permutation + 1 11 6 4 8 2 5 10 7 3 9 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 2 3 6 4 2 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 0 0 + 0 0 0 1 0 0 -1 0 -1 1 0 0 + 0 0 1 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 4 8 10 9 | 7 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 8 0 8 0 -4 + +# Permutation + 1 8 6 4 0 2 5 10 7 3 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 0 2 3 6 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 -1 0 0 + 0 0 0 1 0 0 -1 0 -1 1 0 0 + 0 0 1 0 0 0 0 0 -1 1 0 0 + 1 1 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 6 5 | 2 6 8 7 | 1 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 8 0 8 0 -4 + +# Permutation + 1 2 6 4 8 0 5 10 7 3 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 0 3 6 4 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 0 1 -1 0 0 + 0 0 0 1 0 0 -1 0 -1 1 0 0 + 0 0 1 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 9 3 | 3 4 6 5 | 2 6 8 7 | 4 8 10 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 2 0 2 0 -4 0 -4 0 2 0 -4 0 8 0 8 0 -4 + +# Permutation + 1 7 6 4 10 2 0 8 5 3 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 3 6 2 0 5 3 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 0 1 -1 0 0 + 0 0 0 1 0 0 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 1 0 0 + 1 1 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 1 0 0 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 8 5 | 2 6 1 7 | 7 8 10 9 | 4 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 0 0 0 0 2 0 -4 0 0 0 0 0 2 0 -4 0 0 0 0 0 -4 0 8 0 0 0 0 + +# Permutation + 1 3 6 4 10 2 7 8 5 0 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 6 2 4 5 3 0 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 0 0 1 -1 0 0 + 1 1 0 1 0 0 0 0 -1 1 0 0 + 1 1 1 0 0 0 0 1 0 1 0 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 1 0 0 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 8 5 | 2 6 6 7 | 7 8 10 9 | 4 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 0 0 0 0 2 0 -4 0 0 0 0 0 2 0 -4 0 0 0 0 0 -4 0 8 0 0 0 0 + +# Permutation + 1 2 6 4 10 0 7 8 5 3 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 6 0 4 5 3 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 1 -1 0 0 + 0 0 0 1 0 0 0 0 -1 1 0 0 + 0 0 1 0 0 0 0 1 0 1 0 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 1 0 0 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 9 3 | 3 4 8 5 | 2 6 6 7 | 7 8 10 9 | 4 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 2 0 0 0 0 0 2 0 -4 0 0 0 0 0 2 0 -4 0 0 0 0 0 -4 0 8 0 0 0 0 + +# Permutation + 1 5 2 6 3 10 7 8 0 4 9 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 4 2 6 4 5 0 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 0 0 0 -1 1 0 0 + 1 1 0 1 1 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 1 1 0 0 0 1 0 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 9 4 1 5 | 3 6 6 7 | 7 8 10 9 | 5 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 0 -4 0 0 0 0 0 -4 0 2 0 0 0 0 + +# Permutation + 1 7 2 6 3 10 0 8 5 4 9 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 4 2 6 0 5 3 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 1 1 0 0 0 + 1 1 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 9 4 8 5 | 3 6 1 7 | 7 8 10 9 | 5 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 0 -4 0 0 0 0 0 -4 0 2 0 0 0 0 + +# Permutation + 1 2 0 6 3 10 7 8 5 4 9 11 +# SymFactor +0.5 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 4 2 6 4 5 3 3 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 9 4 8 5 | 3 6 6 7 | 7 8 10 9 | 5 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 0 -4 0 0 0 0 0 -4 0 2 0 0 0 0 + +# Permutation + 1 11 2 6 3 10 7 8 5 4 9 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 4 2 6 4 5 3 3 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 1 1 0 0 1 1 0 0 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 1 0 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 9 4 8 5 | 3 6 6 7 | 7 8 10 9 | 5 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 0 -4 0 0 0 0 0 -4 0 2 0 0 0 0 + +# Permutation + 1 4 10 6 7 8 5 0 3 2 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 6 4 4 5 3 0 2 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -1 1 0 0 + 1 1 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 0 1 1 0 1 0 0 0 + 0 0 0 0 1 0 1 0 0 0 0 0 + 0 0 1 0 0 0 0 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 8 3 | 1 4 6 5 | 3 6 4 7 | 5 8 10 9 | 2 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -8 0 4 0 4 0 -2 0 4 0 -2 0 -8 0 4 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -8 + +# Permutation + 1 7 10 6 0 8 5 4 3 2 9 11 +# SymFactor +-0.25 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 6 4 0 5 3 3 2 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 0 1 1 0 1 0 0 0 + 1 1 0 0 1 0 1 0 0 0 0 0 + 0 0 1 0 0 0 0 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 8 3 | 7 4 6 5 | 3 6 1 7 | 5 8 10 9 | 2 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -8 0 4 0 4 0 -2 0 4 0 -2 0 -8 0 4 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -8 + +# Permutation + 1 3 10 6 7 8 5 4 0 2 9 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 6 4 4 5 3 3 0 2 5 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 1 1 0 1 0 1 1 0 1 0 0 0 + 0 0 0 0 1 0 1 0 0 0 0 0 + 1 1 1 0 0 0 0 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 1 3 | 7 4 6 5 | 3 6 4 7 | 5 8 10 9 | 2 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -8 0 4 0 4 0 -2 0 4 0 -2 0 -8 0 4 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -8 + +# Permutation + 1 11 10 6 7 8 5 4 3 2 9 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 6 4 4 5 3 3 2 2 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 0 0 0 1 0 1 1 0 1 0 0 0 + 0 0 0 0 1 0 1 0 0 0 0 0 + 0 0 1 0 0 0 0 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 8 3 | 7 4 6 5 | 3 6 4 7 | 5 8 10 9 | 2 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -8 0 4 0 4 0 -2 0 4 0 -2 0 -8 0 4 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -8 + +# Permutation + 1 11 6 8 3 2 5 4 9 10 7 0 +# SymFactor +0.25 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 5 2 2 3 3 5 6 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 -1 1 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 10 7 | 3 8 8 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 2 0 0 + +# Permutation + 1 5 6 8 3 2 0 4 9 10 7 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 5 2 2 0 3 5 6 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 1 1 1 0 1 0 1 0 0 0 0 0 + 0 0 -1 1 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 1 5 | 2 6 10 7 | 3 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 2 0 0 + +# Permutation + 1 3 6 8 0 2 5 4 9 10 7 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 5 0 2 3 3 5 6 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 0 0 + 1 1 1 0 1 0 1 0 0 0 0 0 + 0 0 -1 1 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 7 4 6 5 | 2 6 10 7 | 3 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 2 0 0 + +# Permutation + 1 6 0 8 3 2 5 4 9 10 7 11 +# SymFactor +0.25 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 5 2 2 3 3 5 6 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 0 0 + 1 1 1 0 1 0 1 0 0 0 0 0 +-1 -1 -1 1 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 10 7 | 3 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 2 0 0 + +# Permutation + 1 9 6 8 3 2 5 4 0 10 7 11 +# SymFactor +0.25 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 5 2 2 3 3 0 6 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 -1 1 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 10 7 | 3 8 1 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 2 0 0 + +# Permutation + 1 4 6 0 8 2 5 3 9 10 7 11 +# SymFactor +1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 5 2 3 2 5 6 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 0 0 + 1 1 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 10 7 | 4 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 8 0 0 + +# Permutation + 1 11 6 4 8 2 5 3 9 10 7 0 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 2 3 2 5 6 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 10 7 | 4 8 8 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 8 0 0 + +# Permutation + 1 3 6 4 8 2 5 0 9 10 7 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 2 3 0 5 6 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 0 0 + 1 1 0 1 0 0 -1 1 0 0 0 0 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 10 7 | 4 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 8 0 0 + +# Permutation + 1 5 6 4 8 2 0 3 9 10 7 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 3 5 2 0 2 5 6 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 0 0 +-1 -1 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 1 1 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 10 7 | 4 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 8 0 0 + +# Permutation + 1 2 6 4 8 0 5 3 9 10 7 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 0 3 2 5 6 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 10 7 | 4 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 8 0 0 + +# Permutation + 1 9 6 4 8 2 5 3 0 10 7 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 5 2 3 2 0 6 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 1 1 0 + 1 1 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 10 7 | 4 8 1 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 8 0 0 + +# Permutation + 1 6 0 4 8 2 5 3 9 10 7 11 +# SymFactor +1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 3 5 2 3 2 5 6 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 10 7 | 4 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 2 0 0 0 2 0 0 0 -4 0 0 0 2 0 0 0 -4 0 0 0 -4 0 0 0 8 0 0 + +# Permutation + 1 4 6 0 3 2 7 8 9 10 5 11 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 2 2 4 5 5 6 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 10 5 | 2 6 6 7 | 7 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 -4 0 0 0 0 0 0 + +# Permutation + 1 3 6 4 0 2 7 8 9 10 5 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 0 2 4 5 5 6 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 10 5 | 2 6 6 7 | 7 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 -4 0 0 0 0 0 0 + +# Permutation + 1 11 6 4 3 2 7 8 9 10 5 0 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 2 2 4 5 5 6 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 10 5 | 2 6 6 7 | 7 8 8 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 -4 0 0 0 0 0 0 + +# Permutation + 1 7 6 4 3 2 0 8 9 10 5 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 3 2 2 0 5 5 6 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 1 1 0 + 1 1 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 10 5 | 2 6 1 7 | 7 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 -4 0 0 0 0 0 0 + +# Permutation + 1 9 6 4 3 2 7 8 0 10 5 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 2 2 4 5 0 6 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 1 1 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 10 5 | 2 6 6 7 | 7 8 1 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 -4 0 0 0 0 0 0 + +# Permutation + 1 4 2 6 3 0 7 8 9 10 5 11 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 4 2 0 4 5 5 6 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 1 0 1 1 0 + 0 0 0 0 0 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 | 1 4 10 5 | 3 6 6 7 | 7 8 8 9 | 9 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 2 0 0 0 0 0 0 0 0 0 0 0 0 0 0 + +# Permutation + 1 5 6 8 3 2 10 9 7 0 4 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 5 2 2 6 5 4 0 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 1 0 + 1 1 1 0 1 0 0 0 -1 1 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 |10 4 1 5 | 2 6 8 7 | 3 8 7 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -2 0 4 0 -8 0 -2 0 4 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 8 6 0 3 2 10 9 7 5 4 11 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 0 2 2 6 5 4 3 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 1 0 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 1 1 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 |10 4 9 5 | 2 6 8 7 | 1 8 7 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -2 0 4 0 -8 0 -2 0 4 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 2 6 8 3 0 10 9 7 5 4 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 5 2 0 6 5 4 3 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 1 0 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 |10 4 9 5 | 2 6 8 7 | 3 8 7 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -2 0 4 0 -8 0 -2 0 4 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 9 6 8 3 2 10 0 7 5 4 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 5 2 2 6 0 4 3 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 1 0 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 |10 4 9 5 | 2 6 8 7 | 3 8 1 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -2 0 4 0 -8 0 -2 0 4 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 11 6 8 3 2 10 9 7 5 4 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 5 2 2 6 5 4 3 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 1 0 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 |10 4 9 5 | 2 6 8 7 | 3 8 7 9 | 6 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -2 0 4 0 -8 0 -2 0 4 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 7 6 8 3 2 10 9 0 5 4 11 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 5 2 2 6 5 0 3 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 1 0 +-1 -1 1 0 1 0 0 0 -1 1 0 0 + 1 1 -1 1 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 |10 4 9 5 | 2 6 1 7 | 3 8 7 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -2 0 4 0 -8 0 -2 0 4 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 6 0 8 3 2 10 9 7 5 4 11 +# SymFactor +-0.5 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 5 2 2 6 5 4 3 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 1 0 0 0 1 0 + 1 1 1 0 1 0 0 0 -1 1 0 0 +-1 -1 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 |10 4 9 5 | 1 6 8 7 | 3 8 7 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -2 0 4 0 -8 0 -2 0 4 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 6 0 4 8 2 9 10 7 3 5 11 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 3 5 2 5 6 4 2 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 1 1 -1 1 0 + 0 0 0 1 0 0 0 -1 -1 1 -1 0 + 1 1 1 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 1 1 0 1 0 + 0 0 0 0 0 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 10 5 | 1 6 8 7 | 4 8 6 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 2 6 4 8 0 9 10 7 3 5 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 0 5 6 4 2 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 1 1 -1 1 0 + 0 0 0 1 0 0 0 -1 -1 1 -1 0 + 0 0 1 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 1 1 0 1 0 + 0 0 0 0 0 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 9 3 | 3 4 10 5 | 2 6 8 7 | 4 8 6 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 11 6 4 8 2 9 10 7 3 5 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 2 5 6 4 2 3 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 1 1 -1 1 0 + 0 0 0 1 0 0 0 -1 -1 1 -1 0 + 0 0 1 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 1 1 0 1 0 + 0 0 0 0 0 0 1 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 10 5 | 2 6 8 7 | 4 8 6 9 | 7 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 7 6 4 8 2 9 10 0 3 5 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 3 5 2 5 6 0 2 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 1 1 -1 1 0 +-1 -1 0 1 0 0 0 -1 -1 1 -1 0 +-1 -1 1 0 0 0 0 0 -1 1 0 0 + 1 1 0 0 1 0 0 1 1 0 1 0 + 1 1 0 0 0 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 10 5 | 2 6 1 7 | 4 8 6 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 8 6 4 0 2 9 10 7 3 5 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 0 2 5 6 4 2 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 1 1 -1 1 0 + 0 0 0 1 0 0 0 -1 -1 1 -1 0 + 0 0 1 0 0 0 0 0 -1 1 0 0 + 1 1 0 0 1 0 0 1 1 0 1 0 + 0 0 0 0 0 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 10 5 | 2 6 8 7 | 1 8 6 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 9 6 4 8 2 0 10 7 3 5 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 5 2 0 6 4 2 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 1 1 -1 1 0 + 0 0 0 1 0 0 0 -1 -1 1 -1 0 + 0 0 1 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 1 1 0 1 0 + 1 1 0 0 0 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 3 4 10 5 | 2 6 8 7 | 4 8 1 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 3 6 4 8 2 9 10 7 0 5 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 2 5 6 4 0 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 0 1 1 -1 1 0 + 1 1 0 1 0 0 0 -1 -1 1 -1 0 + 1 1 1 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 1 1 0 1 0 + 0 0 0 0 0 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 10 5 | 2 6 8 7 | 4 8 6 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 4 6 0 8 2 9 10 7 3 5 11 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 5 2 5 6 4 2 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 1 1 -1 1 0 + 1 1 0 1 0 0 0 -1 -1 1 -1 0 + 0 0 1 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 1 1 0 1 0 + 0 0 0 0 0 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 9 3 | 1 4 10 5 | 2 6 8 7 | 4 8 6 9 | 7 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -2 0 4 0 4 0 -8 0 4 0 -2 0 -2 0 4 0 4 0 -2 0 -2 0 4 0 -8 0 4 0 4 0 -8 + +# Permutation + 1 9 2 6 3 8 10 0 7 5 4 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 2 4 2 5 6 0 4 3 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 1 0 1 -1 1 0 + 0 0 0 1 1 0 0 0 -1 1 0 0 + 0 0 0 0 0 1 0 0 0 1 0 0 + 1 1 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 |10 4 9 5 | 3 6 8 7 | 5 8 1 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 2 0 6 3 8 10 9 7 5 4 11 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 4 2 5 6 5 4 3 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 1 0 1 -1 1 0 + 0 0 0 1 1 0 0 0 -1 1 0 0 + 0 0 0 0 0 1 0 0 0 1 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 |10 4 9 5 | 3 6 8 7 | 5 8 7 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 5 2 6 3 8 10 9 7 0 4 11 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 4 2 5 6 5 4 0 3 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 0 1 0 1 -1 1 0 + 1 1 0 1 1 0 0 0 -1 1 0 0 + 1 1 0 0 0 1 0 0 0 1 0 0 + 0 0 0 0 0 0 0 1 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 4 3 |10 4 1 5 | 3 6 8 7 | 5 8 7 9 | 6 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 4 0 -8 0 -2 0 4 0 -2 0 4 0 4 0 -2 + +# Permutation + 1 7 10 9 0 8 5 4 3 2 6 11 +# SymFactor +0.25 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 6 5 0 5 3 3 2 2 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 1 1 0 1 0 1 0 + 1 1 0 0 1 0 1 0 0 0 0 0 + 0 0 0 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 8 3 | 7 4 6 5 |10 6 1 7 | 5 8 3 9 | 2 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 8 0 -4 0 -4 0 2 0 -4 0 2 0 8 0 -4 + +# Permutation + 1 4 10 9 7 8 5 0 3 2 6 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 6 5 4 5 3 0 2 2 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -1 1 0 0 + 1 1 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 1 1 0 1 0 1 0 + 0 0 0 0 1 0 1 0 0 0 0 0 + 0 0 0 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 8 3 | 1 4 6 5 |10 6 4 7 | 5 8 3 9 | 2 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 8 0 -4 0 -4 0 2 0 -4 0 2 0 8 0 -4 + +# Permutation + 1 11 10 9 7 8 5 4 3 2 6 0 +# SymFactor +0.25 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 6 5 4 5 3 3 2 2 4 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 1 1 0 1 0 1 0 + 0 0 0 0 1 0 1 0 0 0 0 0 + 0 0 0 1 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 8 3 | 7 4 6 5 |10 6 4 7 | 5 8 3 9 | 2 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 8 0 -4 0 -4 0 2 0 -4 0 2 0 8 0 -4 + +# Permutation + 1 3 10 9 7 8 5 4 0 2 6 11 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 6 5 4 5 3 3 0 2 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 1 1 1 0 0 1 1 0 1 0 1 0 + 0 0 0 0 1 0 1 0 0 0 0 0 + 1 1 0 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 1 3 | 7 4 6 5 |10 6 4 7 | 5 8 3 9 | 2 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 8 0 -4 0 -4 0 2 0 -4 0 2 0 8 0 -4 + +# Permutation + 1 9 10 0 7 8 5 4 3 2 6 11 +# SymFactor +0.25 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 6 0 4 5 3 3 2 2 4 6 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -1 1 0 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 1 1 0 1 0 1 0 + 0 0 0 0 1 0 1 0 0 0 0 0 + 1 1 0 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 8 3 | 7 4 6 5 |10 6 4 7 | 5 8 1 9 | 2 10 11 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 -4 0 8 0 2 0 -4 0 2 0 -4 0 -4 0 8 0 8 0 -4 0 -4 0 2 0 -4 0 2 0 8 0 -4 + +# Permutation + 1 9 6 4 3 2 5 8 11 10 0 7 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 2 2 3 5 6 6 0 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 +-1 -1 0 0 0 0 0 1 0 0 -1 1 + 1 1 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 11 7 | 7 8 1 9 | 9 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 -8 4 4 -8 0 0 0 0 4 -2 -2 4 0 0 0 0 4 -2 -2 4 0 0 0 0 -8 4 4 -8 + +# Permutation + 1 11 6 4 3 2 5 8 0 10 9 7 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 2 2 3 5 0 6 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 0 0 0 0 0 1 0 0 -1 1 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 3 4 6 5 | 2 6 11 7 | 7 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 -8 4 4 -8 0 0 0 0 4 -2 -2 4 0 0 0 0 4 -2 -2 4 0 0 0 0 -8 4 4 -8 + +# Permutation + 1 4 6 8 3 2 5 0 11 10 9 7 +# SymFactor +0.25 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 5 2 2 3 0 6 6 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 -1 1 0 0 0 0 0 0 -1 1 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 2 6 11 7 | 3 8 10 9 | 9 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -4 2 2 -4 + +# Permutation + 1 11 6 8 3 2 5 4 0 10 9 7 +# SymFactor +0.25 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 5 2 2 3 3 0 6 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 -1 1 0 0 0 0 0 0 -1 1 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 11 7 | 3 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -4 2 2 -4 + +# Permutation + 1 2 6 8 3 0 5 4 11 10 9 7 +# SymFactor +0.25 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 5 2 0 3 3 6 6 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 + 0 0 -1 1 0 0 0 0 0 0 -1 1 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 2 6 11 7 | 3 8 10 9 | 9 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -4 2 2 -4 + +# Permutation + 1 9 6 8 3 2 5 4 11 10 0 7 +# SymFactor +0.125 +# GType +-2 -2 0 0 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 5 2 2 3 3 6 6 0 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 0 +-1 -1 -1 1 0 0 0 0 0 0 -1 1 + 1 1 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 2 6 11 7 | 3 8 1 9 | 9 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -4 2 2 -4 + +# Permutation + 1 6 0 8 3 2 5 4 11 10 9 7 +# SymFactor +0.125 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 5 2 2 3 3 6 6 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 0 0 + 1 1 1 0 1 0 1 0 0 0 0 0 +-1 -1 -1 1 0 0 0 0 0 0 -1 1 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 1 6 11 7 | 3 8 10 9 | 9 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -4 2 2 -4 + +# Permutation + 1 2 6 4 8 0 5 3 11 10 9 7 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 0 3 2 6 6 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 7 3 | 3 4 6 5 | 2 6 11 7 | 4 8 10 9 | 9 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -16 8 8 -16 + +# Permutation + 1 6 0 4 8 2 5 3 11 10 9 7 +# SymFactor +0.5 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 3 5 2 3 2 6 6 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 1 6 11 7 | 4 8 10 9 | 9 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -16 8 8 -16 + +# Permutation + 1 11 6 4 8 2 5 3 0 10 9 7 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 2 3 2 0 6 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 11 7 | 4 8 10 9 | 9 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -16 8 8 -16 + +# Permutation + 1 3 6 4 8 2 5 0 11 10 9 7 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 2 3 0 6 6 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 -1 0 0 0 0 + 1 1 0 1 0 0 -1 1 0 0 0 0 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 11 7 | 4 8 10 9 | 9 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -16 8 8 -16 + +# Permutation + 1 9 6 4 8 2 5 3 11 10 0 7 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 5 2 3 2 6 6 0 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 +-1 -1 0 0 1 0 1 0 0 0 -1 1 + 1 1 0 0 0 0 0 0 0 1 1 0 + 1 1 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 6 5 | 2 6 11 7 | 4 8 1 9 | 9 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -16 8 8 -16 + +# Permutation + 1 4 6 0 8 2 5 3 11 10 9 7 +# SymFactor +0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 5 2 3 2 6 6 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 -1 0 0 0 0 + 1 1 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 1 4 6 5 | 2 6 11 7 | 4 8 10 9 | 9 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -16 8 8 -16 + +# Permutation + 1 5 6 4 8 2 0 3 11 10 9 7 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 3 5 2 0 2 6 6 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 -1 0 0 0 0 +-1 -1 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 1 1 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 0 0 0 0 0 1 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 11 7 | 4 8 10 9 | 9 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 8 -4 -4 8 -4 2 2 -4 -4 2 2 -4 8 -4 -4 8 -4 2 2 -4 8 -4 -4 8 8 -4 -4 8 -16 8 8 -16 + +# Permutation + 1 5 2 4 8 6 10 11 7 0 9 3 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 2 3 5 4 6 6 4 0 5 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 +-1 -1 0 1 0 0 1 0 1 -1 0 1 + 1 1 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 11 3 | 3 4 1 5 | 5 6 8 7 | 4 8 10 9 | 6 10 7 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 2 2 -4 2 -4 -4 2 2 -4 -4 8 -4 2 8 -4 + +# Permutation + 1 9 2 4 8 6 10 11 7 5 0 3 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 2 3 5 4 6 6 4 3 0 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 1 0 1 -1 0 1 + 0 0 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 11 3 | 3 4 9 5 | 5 6 8 7 | 4 8 1 9 | 6 10 7 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 2 2 -4 2 -4 -4 2 2 -4 -4 8 -4 2 8 -4 + +# Permutation + 1 7 2 4 8 6 10 11 0 5 9 3 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 3 5 4 6 6 0 3 5 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 1 1 0 1 0 0 1 0 1 -1 0 1 +-1 -1 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 11 3 | 3 4 9 5 | 5 6 1 7 | 4 8 10 9 | 6 10 7 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 2 2 -4 2 -4 -4 2 2 -4 -4 8 -4 2 8 -4 + +# Permutation + 1 8 2 4 0 6 10 11 7 5 9 3 +# SymFactor +0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 2 3 0 4 6 6 4 3 5 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 1 0 1 -1 0 1 + 0 0 0 0 0 1 0 0 -1 1 0 0 + 1 1 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 11 3 | 3 4 9 5 | 5 6 8 7 | 1 8 10 9 | 6 10 7 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 2 2 -4 2 -4 -4 2 2 -4 -4 8 -4 2 8 -4 + +# Permutation + 1 11 2 4 8 6 10 0 7 5 9 3 +# SymFactor +1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 3 5 4 6 0 4 3 5 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 1 0 1 -1 0 1 + 0 0 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 11 3 | 3 4 9 5 | 5 6 8 7 | 4 8 10 9 | 6 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 2 2 -4 2 -4 -4 2 2 -4 -4 8 -4 2 8 -4 + +# Permutation + 1 6 2 4 8 0 10 11 7 5 9 3 +# SymFactor +0.5 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 3 5 0 6 6 4 3 5 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 1 0 1 -1 0 1 + 1 1 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 11 3 | 3 4 9 5 | 1 6 8 7 | 4 8 10 9 | 6 10 7 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 2 2 -4 2 -4 -4 2 2 -4 -4 8 -4 2 8 -4 + +# Permutation + 1 2 0 4 8 6 10 11 7 5 9 3 +# SymFactor +0.5 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 0 3 5 4 6 6 4 3 5 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 0 0 1 0 1 -1 0 1 + 0 0 0 0 0 1 0 0 -1 1 0 0 + 0 0 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 11 3 | 3 4 9 5 | 5 6 8 7 | 4 8 10 9 | 6 10 7 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 2 2 -4 2 -4 -4 2 2 -4 -4 8 -4 2 8 -4 + +# Permutation + 1 10 2 4 0 11 5 6 7 3 9 8 +# SymFactor +0.25 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 2 3 0 6 3 4 4 2 5 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 1 1 0 1 1 0 0 0 0 1 0 1 + 0 0 0 0 0 0 0 1 0 0 0 0 + 1 1 0 0 1 0 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 0 0 1 -1 +-1 -1 0 0 -1 1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 9 3 | 3 4 6 5 | 7 6 8 7 |11 8 10 9 | 1 10 5 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 2 2 -4 0 0 0 0 2 -4 -4 2 0 0 0 0 + +# Permutation + 1 8 2 4 10 11 5 6 7 3 9 0 +# SymFactor +0.25 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 2 3 6 6 3 4 4 2 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 1 1 0 1 1 0 0 0 0 1 0 1 + 0 0 0 0 0 0 0 1 0 0 0 0 + 1 1 0 0 1 0 1 0 1 0 0 1 +-1 -1 0 0 0 0 0 0 0 0 1 -1 + 0 0 0 0 -1 1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 9 3 | 3 4 6 5 | 7 6 8 7 | 1 8 10 9 | 4 10 5 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 2 2 -4 0 0 0 0 2 -4 -4 2 0 0 0 0 + +# Permutation + 1 6 2 4 10 11 5 0 7 3 9 8 +# SymFactor +0.25 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 2 3 6 6 3 0 4 2 5 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 1 0 0 0 0 0 0 0 0 0 + 0 0 0 1 1 0 0 0 0 1 0 1 + 1 1 0 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 1 0 0 1 + 0 0 0 0 0 0 0 0 0 0 1 -1 + 0 0 0 0 -1 1 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 2 2 9 3 | 3 4 6 5 | 1 6 8 7 |11 8 10 9 | 4 10 5 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -4 2 2 -4 0 0 0 0 2 -4 -4 2 0 0 0 0 + +# Permutation + 1 7 10 11 3 2 5 4 0 6 9 8 +# SymFactor +-0.0625 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 6 6 2 2 3 3 0 4 5 5 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 1 0 1 + 0 0 1 0 1 0 1 0 0 1 0 1 + 1 1 0 0 0 0 0 0 1 -1 0 0 + 0 0 0 0 0 0 0 0 0 0 1 -1 + 0 0 -1 1 0 0 0 0 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 9 6 1 7 |11 8 10 9 | 2 10 3 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -2 4 -2 -2 4 -2 4 4 -2 4 -2 -2 4 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 9 10 8 3 2 5 4 11 6 0 7 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 6 5 2 2 3 3 6 4 0 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 1 0 1 0 0 + 0 0 0 1 1 0 1 0 0 1 0 0 +-1 -1 0 0 0 0 0 0 0 -1 -1 1 + 1 1 1 -1 0 0 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 9 6 11 7 | 3 8 1 9 | 2 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 -2 4 4 -8 4 -2 -2 4 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 4 10 8 3 2 5 0 11 6 9 7 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 6 5 2 2 3 0 6 4 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 0 1 1 0 0 1 0 1 0 0 + 0 0 0 1 1 0 1 0 0 1 0 0 + 0 0 0 0 0 0 0 0 0 -1 -1 1 + 0 0 1 -1 0 0 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 6 5 | 9 6 11 7 | 3 8 10 9 | 2 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 -2 4 4 -8 4 -2 -2 4 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 10 0 8 3 2 5 4 11 6 9 7 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 0 5 2 2 3 3 6 4 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 1 0 1 0 0 + 0 0 0 1 1 0 1 0 0 1 0 0 + 0 0 0 0 0 0 0 0 0 -1 -1 1 + 1 1 1 -1 0 0 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 9 6 11 7 | 3 8 10 9 | 1 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 -2 4 4 -8 4 -2 -2 4 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 10 8 3 2 5 4 11 6 9 0 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 6 5 2 2 3 3 6 4 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 1 0 1 0 0 + 0 0 0 1 1 0 1 0 0 1 0 0 + 1 1 0 0 0 0 0 0 0 -1 -1 1 + 0 0 1 -1 0 0 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 6 5 | 9 6 1 7 | 3 8 10 9 | 2 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 -2 4 4 -8 4 -2 -2 4 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 2 10 8 3 0 5 4 11 6 9 7 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 6 5 2 0 3 3 6 4 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 0 0 + 0 0 0 1 1 0 0 1 0 1 0 0 + 0 0 0 1 1 0 1 0 0 1 0 0 + 0 0 0 0 0 0 0 0 0 -1 -1 1 + 0 0 1 -1 0 0 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 6 5 | 9 6 11 7 | 3 8 10 9 | 2 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 -2 4 4 -8 4 -2 -2 4 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 6 0 8 3 2 10 11 7 5 9 4 +# SymFactor +-0.25 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 5 2 2 6 6 4 3 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 1 0 0 0 0 1 + 1 1 1 0 1 0 0 0 -1 1 0 0 +-1 -1 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 |11 4 9 5 | 1 6 8 7 | 3 8 10 9 | 6 10 7 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -8 4 -2 -8 4 -2 4 4 -8 4 -2 -8 4 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 3 6 8 0 2 10 11 7 5 9 4 +# SymFactor +-0.5 +# GType +-2 -2 0 0 -2 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 5 0 2 6 6 4 3 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 1 0 0 0 0 1 + 1 1 1 0 1 0 0 0 -1 1 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 |11 4 9 5 | 2 6 8 7 | 3 8 10 9 | 6 10 7 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -8 4 -2 -8 4 -2 4 4 -8 4 -2 -8 4 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 9 6 8 3 2 10 11 7 5 0 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 5 2 2 6 6 4 3 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 1 + 0 0 1 0 1 0 0 0 -1 1 0 0 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 |11 4 9 5 | 2 6 8 7 | 3 8 1 9 | 6 10 7 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -8 4 -2 -8 4 -2 4 4 -8 4 -2 -8 4 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 7 6 8 3 2 10 11 0 5 9 4 +# SymFactor +-0.25 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 5 2 2 6 6 0 3 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 1 0 0 0 0 1 +-1 -1 1 0 1 0 0 0 -1 1 0 0 + 1 1 -1 1 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 -1 1 0 0 0 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 |11 4 9 5 | 2 6 1 7 | 3 8 10 9 | 6 10 7 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -2 -2 4 4 -8 4 -2 -8 4 -2 4 4 -8 4 -2 -8 4 4 -2 -2 4 -2 4 4 -2 + +# Permutation + 1 4 6 8 3 2 10 0 11 5 9 7 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 5 2 2 6 0 6 3 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 0 1 1 -1 + 0 0 -1 1 0 0 0 0 0 0 -1 1 + 0 0 0 0 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 9 5 | 2 6 11 7 | 3 8 10 9 | 6 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 -2 4 4 -8 4 -8 -8 16 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 2 6 8 3 0 10 4 11 5 9 7 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 5 2 0 6 3 6 3 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 0 1 1 -1 + 0 0 -1 1 0 0 0 0 0 0 -1 1 + 0 0 0 0 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 9 5 | 2 6 11 7 | 3 8 10 9 | 6 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 -2 4 4 -8 4 -8 -8 16 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 11 6 8 3 2 10 4 0 5 9 7 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 5 2 2 6 3 0 3 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 0 1 1 -1 + 0 0 -1 1 0 0 0 0 0 0 -1 1 + 0 0 0 0 0 0 1 0 0 0 0 1 + 1 1 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 11 7 | 3 8 10 9 | 6 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 -2 4 4 -8 4 -8 -8 16 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 7 6 8 3 2 10 4 11 5 9 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 5 2 2 6 3 6 3 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 +-1 -1 1 0 1 0 0 0 0 1 1 -1 + 1 1 -1 1 0 0 0 0 0 0 -1 1 + 1 1 0 0 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 1 7 | 3 8 10 9 | 6 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 -2 4 4 -8 4 -8 -8 16 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 8 6 0 3 2 10 4 11 5 9 7 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 0 2 2 6 3 6 3 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 0 1 1 -1 + 1 1 -1 1 0 0 0 0 0 0 -1 1 + 0 0 0 0 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 9 5 | 2 6 11 7 | 1 8 10 9 | 6 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 -2 4 4 -8 4 -8 -8 16 4 -2 -2 4 -2 4 4 -8 + +# Permutation + 1 6 0 8 3 2 10 4 7 11 9 5 +# SymFactor +-0.5 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 5 2 2 6 3 4 6 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 0 -1 1 +-1 -1 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 11 5 | 1 6 8 7 | 3 8 10 9 | 6 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -2 4 -2 4 4 -2 + +# Permutation + 1 11 6 8 3 2 10 4 7 0 9 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 5 2 2 6 3 4 0 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 11 5 | 2 6 8 7 | 3 8 10 9 | 6 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -2 4 -2 4 4 -2 + +# Permutation + 1 4 6 8 3 2 10 0 7 11 9 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 5 2 2 6 0 4 6 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 1 1 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 1 4 11 5 | 2 6 8 7 | 3 8 10 9 | 6 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -2 4 -2 4 4 -2 + +# Permutation + 1 10 6 8 3 2 0 4 7 11 9 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 5 2 2 0 3 4 6 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 11 5 | 2 6 8 7 | 3 8 10 9 | 1 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -2 4 -2 4 4 -2 + +# Permutation + 1 2 6 8 3 0 10 4 7 11 9 5 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 5 2 0 6 3 4 6 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 1 2 4 3 | 7 4 11 5 | 2 6 8 7 | 3 8 10 9 | 6 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -2 4 -2 4 4 -2 + +# Permutation + 1 8 6 0 3 2 10 4 7 11 9 5 +# SymFactor +-0.5 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 0 2 2 6 3 4 6 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 0 0 1 0 1 0 0 0 -1 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 11 5 | 2 6 8 7 | 1 8 10 9 | 6 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -2 4 -2 4 4 -2 + +# Permutation + 1 7 6 8 3 2 10 4 0 11 9 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 5 2 2 6 3 0 6 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 +-1 -1 1 0 1 0 0 0 -1 0 -1 1 + 1 1 -1 1 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 11 5 | 2 6 1 7 | 3 8 10 9 | 6 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -2 4 -2 4 4 -2 + +# Permutation + 1 9 6 8 3 2 10 4 7 11 0 5 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 5 2 2 6 3 4 6 0 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 +-1 -1 1 0 1 0 0 0 -1 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 1 1 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 11 5 | 2 6 8 7 | 3 8 1 9 | 6 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -2 4 -2 4 4 -2 + +# Permutation + 1 5 6 8 3 2 10 4 7 11 9 0 +# SymFactor +-0.5 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 5 2 2 6 3 4 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 -1 1 0 0 0 0 0 0 + 0 0 1 0 1 0 0 1 0 0 0 0 + 1 1 1 0 1 0 0 0 -1 0 -1 1 + 0 0 -1 1 0 0 0 0 1 0 0 0 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 4 3 | 7 4 1 5 | 2 6 8 7 | 3 8 10 9 | 6 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -2 4 -2 4 4 -2 + +# Permutation + 1 11 6 4 8 10 5 3 0 2 9 7 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 6 3 2 0 2 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 1 0 1 -1 0 1 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 1 1 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 7 3 | 3 4 6 5 | 2 6 11 7 | 4 8 10 9 | 5 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 -2 4 4 -8 4 -8 -8 16 4 -2 -2 4 -8 4 4 -8 + +# Permutation + 1 10 6 4 8 0 5 3 11 2 9 7 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 -2 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 0 3 2 6 2 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 1 0 1 -1 0 1 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 0 -1 1 + 1 1 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 7 3 | 3 4 6 5 | 2 6 11 7 | 4 8 10 9 | 1 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 -2 4 4 -8 4 -8 -8 16 4 -2 -2 4 -8 4 4 -8 + +# Permutation + 1 7 6 4 8 10 5 3 11 2 9 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 3 5 6 3 2 6 2 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 1 0 1 -1 0 1 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 1 1 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 7 3 | 3 4 6 5 | 2 6 1 7 | 4 8 10 9 | 5 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 -2 4 4 -8 4 -8 -8 16 4 -2 -2 4 -8 4 4 -8 + +# Permutation + 1 4 6 0 8 10 5 3 11 2 9 7 +# SymFactor +-1.0 +# GType +-2 -2 0 -2 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 0 5 6 3 2 6 2 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 1 0 1 -1 0 1 0 0 + 1 1 0 1 0 0 -1 1 0 0 0 0 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 7 3 | 1 4 6 5 | 2 6 11 7 | 4 8 10 9 | 5 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 -2 4 4 -8 4 -8 -8 16 4 -2 -2 4 -8 4 4 -8 + +# Permutation + 1 6 0 4 8 10 5 3 11 2 9 7 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 3 5 6 3 2 6 2 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 1 0 1 -1 0 1 0 0 + 0 0 0 1 0 0 -1 1 0 0 0 0 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 1 0 0 0 -1 1 + 0 0 0 0 -1 1 0 0 0 0 1 0 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 9 2 7 3 | 3 4 6 5 | 1 6 11 7 | 4 8 10 9 | 5 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -2 -2 4 -2 4 4 -8 4 -8 -8 16 4 -2 -2 4 -8 4 4 -8 + +# Permutation + 1 5 6 4 8 2 10 3 11 0 9 7 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 3 5 2 6 2 6 0 5 4 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 0 -1 0 1 1 -1 +-1 -1 0 1 0 0 0 1 0 -1 -1 1 + 0 0 1 0 0 0 0 1 0 0 0 0 + 1 1 0 0 1 0 0 0 0 1 0 0 + 0 0 0 0 0 0 1 0 0 0 0 1 + 0 0 0 0 0 0 0 0 1 0 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 1 5 | 2 6 11 7 | 4 8 10 9 | 6 10 8 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -2 -2 4 -2 4 4 -8 -2 4 4 -8 4 -8 -8 16 -2 4 4 -8 4 -8 -8 16 4 -8 -8 16 -8 16 16 -32 + +# Permutation + 1 11 6 4 8 2 10 3 7 0 9 5 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 2 6 2 4 0 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 0 -1 1 + 0 0 0 1 0 0 0 1 1 0 1 -1 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 0 0 1 0 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 11 5 | 2 6 8 7 | 4 8 10 9 | 6 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -8 4 -8 16 16 -8 + +# Permutation + 1 10 6 4 8 2 0 3 7 11 9 5 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 2 0 2 4 6 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 0 -1 1 + 0 0 0 1 0 0 0 1 1 0 1 -1 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 11 5 | 2 6 8 7 | 4 8 10 9 | 1 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -8 4 -8 16 16 -8 + +# Permutation + 1 3 6 4 8 2 10 0 7 11 9 5 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 -2 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 2 6 0 4 6 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 0 -1 -1 0 -1 1 + 1 1 0 1 0 0 0 1 1 0 1 -1 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 11 5 | 2 6 8 7 | 4 8 10 9 | 6 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -8 4 -8 16 16 -8 + +# Permutation + 1 6 0 4 8 2 10 3 7 11 9 5 +# SymFactor +-1.0 +# GType +-2 -2 -2 0 0 0 0 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 0 3 5 2 6 2 4 6 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 0 -1 -1 0 -1 1 + 0 0 0 1 0 0 0 1 1 0 1 -1 + 1 1 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 0 0 0 0 -1 1 + 0 0 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 11 5 | 1 6 8 7 | 4 8 10 9 | 6 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -8 4 -8 16 16 -8 + +# Permutation + 1 7 6 4 8 2 10 3 0 11 9 5 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 3 5 2 6 2 0 6 5 3 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 0 -1 -1 0 -1 1 + 1 1 0 1 0 0 0 1 1 0 1 -1 + 0 0 1 0 0 0 0 1 0 0 0 0 + 0 0 0 0 1 0 0 0 0 0 -1 1 + 1 1 0 0 0 0 1 0 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 7 3 | 3 4 11 5 | 2 6 1 7 | 4 8 10 9 | 6 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -2 4 -2 4 4 -2 -2 4 4 -2 4 -8 -8 4 -2 4 4 -2 4 -8 -8 4 4 -8 -8 4 -8 16 16 -8 + +# Permutation + 1 3 6 4 8 2 5 10 7 11 9 0 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 0 -2 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 2 4 3 5 2 3 6 4 6 5 0 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 +-1 -1 0 0 0 1 1 0 1 0 1 -1 + 1 1 0 1 0 0 -1 0 -1 0 -1 1 + 1 1 1 0 0 0 0 0 -1 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 1 3 | 3 4 6 5 | 2 6 8 7 | 4 8 10 9 | 7 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -8 4 -2 4 4 -2 -2 4 4 -2 4 -8 -2 4 -2 4 4 -2 4 -8 -2 4 4 -8 -8 4 -8 16 4 -8 + +# Permutation + 1 5 6 4 8 2 0 10 7 11 9 3 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 -2 0 0 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 3 4 3 5 2 0 6 4 6 5 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 0 1 0 1 -1 +-1 -1 0 1 0 0 -1 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 11 3 | 3 4 1 5 | 2 6 8 7 | 4 8 10 9 | 7 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -8 4 -2 4 4 -2 -2 4 4 -2 4 -8 -2 4 -2 4 4 -2 4 -8 -2 4 4 -8 -8 4 -8 16 4 -8 + +# Permutation + 1 11 6 4 8 2 5 10 7 0 9 3 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 -2 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 6 4 3 5 2 3 6 4 0 5 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 1 1 0 1 0 1 -1 + 0 0 0 1 0 0 -1 0 -1 0 -1 1 + 0 0 1 0 0 0 0 0 -1 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 0 0 + 0 0 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 11 3 | 3 4 6 5 | 2 6 8 7 | 4 8 10 9 | 7 10 1 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -8 4 -2 4 4 -2 -2 4 4 -2 4 -8 -2 4 -2 4 4 -2 4 -8 -2 4 4 -8 -8 4 -8 16 4 -8 + +# Permutation + 1 7 6 4 8 2 5 10 0 11 9 3 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 -2 0 0 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 4 4 3 5 2 3 6 0 6 5 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 0 1 0 1 -1 +-1 -1 0 1 0 0 -1 0 -1 0 -1 1 +-1 -1 1 0 0 0 0 0 -1 0 -1 1 + 1 1 0 0 1 0 1 0 1 0 0 0 + 1 1 0 0 0 0 0 1 1 0 1 0 + 0 0 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 11 3 | 3 4 6 5 | 2 6 1 7 | 4 8 10 9 | 7 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -8 4 -2 4 4 -2 -2 4 4 -2 4 -8 -2 4 -2 4 4 -2 4 -8 -2 4 4 -8 -8 4 -8 16 4 -8 + +# Permutation + 1 9 6 4 8 2 5 10 7 11 0 3 +# SymFactor +-1.0 +# GType +-2 -2 0 0 0 0 0 0 0 0 -2 0 +# VertexBasis + 0 1 2 2 3 3 4 4 5 5 6 6 + 1 5 4 3 5 2 3 6 4 6 0 2 +# LoopBasis + 1 0 0 0 0 0 0 0 0 0 0 0 + 1 1 0 0 0 1 1 0 1 0 1 -1 +-1 -1 0 1 0 0 -1 0 -1 0 -1 1 +-1 -1 1 0 0 0 0 0 -1 0 -1 1 + 0 0 0 0 1 0 1 0 1 0 0 0 + 1 1 0 0 0 0 0 1 1 0 1 0 + 1 1 0 0 0 0 0 0 0 1 1 0 +# Ver4Legs(InL,OutL,InR,OutR) + 5 2 11 3 | 3 4 6 5 | 2 6 8 7 | 4 8 1 9 | 7 10 9 11 | +# WType(Direct,Exchange) + 0 0 | 0 0 | 0 0 | 0 0 | 0 0 | +# SpinFactor + 4 -8 -8 4 -2 4 4 -2 -2 4 4 -2 4 -8 -2 4 -2 4 4 -2 4 -8 -2 4 4 -8 -8 4 -8 16 4 -8 + From ab58931076da8093863fc2dec3a8775db1ea6450 Mon Sep 17 00:00:00 2001 From: peter0627USTC Date: Sat, 11 Nov 2023 16:43:43 +0800 Subject: [PATCH 04/11] merge new update --- .vscode/launch.json | 17 +++++++++++++++++ 1 file changed, 17 insertions(+) create mode 100644 .vscode/launch.json diff --git a/.vscode/launch.json b/.vscode/launch.json new file mode 100644 index 00000000..c912406a --- /dev/null +++ b/.vscode/launch.json @@ -0,0 +1,17 @@ +{ + // Use IntelliSense to learn about possible attributes. + // Hover to view descriptions of existing attributes. + // For more information, visit: https://go.microsoft.com/fwlink/?linkid=830387 + "version": "0.2.0", + "configurations": [ + { + "type": "julia", + "request": "launch", + "name": "Run active Julia file", + "program": "${file}", + "stopOnEntry": false, + "cwd": "${workspaceFolder}", + "juliaEnv": "${command:activeJuliaEnvironment}" + } + ] +} \ No newline at end of file From f8829af13b3d43e8b8ddbf81bef557716d40cd7e Mon Sep 17 00:00:00 2001 From: ZhiyiLi Date: Mon, 20 Nov 2023 22:50:08 +0800 Subject: [PATCH 05/11] add mindspore.jl --- src/backend/compiler.jl | 1 + src/backend/mindspore.jl | 119 +++++++++++++++++++++++++++++++++++++++ 2 files changed, 120 insertions(+) create mode 100644 src/backend/mindspore.jl diff --git a/src/backend/compiler.jl b/src/backend/compiler.jl index 6559b418..10dedb99 100644 --- a/src/backend/compiler.jl +++ b/src/backend/compiler.jl @@ -8,5 +8,6 @@ using ..RuntimeGeneratedFunctions RuntimeGeneratedFunctions.init(Compilers) include("static.jl") +include("mindspore.jl") end \ No newline at end of file diff --git a/src/backend/mindspore.jl b/src/backend/mindspore.jl new file mode 100644 index 00000000..4f2b1715 --- /dev/null +++ b/src/backend/mindspore.jl @@ -0,0 +1,119 @@ +using PyCall +ms = pyimport("mindspore") + +""" + function to_static(operator::Type, subgraphs::AbstractVector{<:AbstractGraph}, subgraph_factors::AbstractVector) + +Returns the static representation of a computational graph node `g` with operator `operator`, subgraphs `subgraphs`, and subgraph factors `subgraph_factors`. +""" +function to_pystatic(operator::Type, subgraphs::AbstractVector{<:AbstractGraph}, subgraph_factors::AbstractVector) + error( + "Static representation for computational graph nodes with operator $(operator) not yet implemented! " * + "Please define a method `to_static(::Type{$(operator)}, subgraphs::$(typeof(subgraphs)), subgraph_factors::$(typeof(subgraph_factors)))`." + ) +end + +function to_pystatic(::Type{ComputationalGraphs.Sum}, subgraphs::Vector{Graph{F,W}}, subgraph_factors::Vector{F}) where {F,W} + if length(subgraphs) == 1 + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "(g$(subgraphs[1].id)$factor_str)" + else + terms = ["g$(g.id)" * (gfactor == 1 ? "" : " * $gfactor") for (g, gfactor) in zip(subgraphs, subgraph_factors)] + return "(" * join(terms, " + ") * ")" + end +end + +function to_pystatic(::Type{ComputationalGraphs.Prod}, subgraphs::Vector{Graph{F,W}}, subgraph_factors::Vector{F}) where {F,W} + if length(subgraphs) == 1 + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "(g$(subgraphs[1].id)$factor_str)" + else + terms = ["g$(g.id)" * (gfactor == 1 ? "" : " * $gfactor") for (g, gfactor) in zip(subgraphs, subgraph_factors)] + return "(" * join(terms, " * ") * ")" + # return "(" * join(["g$(g.id)" for g in subgraphs], " * ") * ")" + end +end + +function to_pystatic(::Type{ComputationalGraphs.Power{N}}, subgraphs::Vector{Graph{F,W}}, subgraph_factors::Vector{F}) where {N,F,W} + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "((g$(subgraphs[1].id))**$N$factor_str)" +end + +function to_pystatic(::Type{ComputationalGraphs.Sum}, subgraphs::Vector{FeynmanGraph{F,W}}, subgraph_factors::Vector{F}) where {F,W} + if length(subgraphs) == 1 + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "(g$(subgraphs[1].id)$factor_str)" + else + terms = ["g$(g.id)" * (gfactor == 1 ? "" : " * $gfactor") for (g, gfactor) in zip(subgraphs, subgraph_factors)] + return "(" * join(terms, " + ") * ")" + end +end + +function to_pystatic(::Type{ComputationalGraphs.Prod}, subgraphs::Vector{FeynmanGraph{F,W}}, subgraph_factors::Vector{F}) where {F,W} + if length(subgraphs) == 1 + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "(g$(subgraphs[1].id)$factor_str)" + else + terms = ["g$(g.id)" * (gfactor == 1 ? "" : " * $gfactor") for (g, gfactor) in zip(subgraphs, subgraph_factors)] + return "(" * join(terms, " * ") * ")" + end +end + +function to_pystatic(::Type{ComputationalGraphs.Power{N}}, subgraphs::Vector{FeynmanGraph{F,W}}, subgraph_factors::Vector{F}) where {N,F,W} + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "((g$(subgraphs[1].id))**$N$factor_str)" +end + +function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) + head = "import mindspore as ms\n@ms.jit\n" + head *= "def graphfunc():\n" + body = " graph_list = []\n" + leafidx = 1 + root = [id(g) for g in graphs] + inds_visitedleaf = Int[] + inds_visitednode = Int[] + for graph in graphs + for g in PostOrderDFS(graph) #leaf first search + g_id = id(g) + target = "g$(g_id)" + isroot = false + if g_id in root + isroot = true + end + if isempty(subgraphs(g)) #leaf + g_id in inds_visitedleaf && continue + factor_str = factor(g) == 1 ? "" : " * $(factor(g))" + body *= " $target = ms.Tensor(1.0)$factor_str\n" + leafidx += 1 + push!(inds_visitedleaf, g_id) + else + g_id in inds_visitednode && continue + factor_str = factor(g) == 1 ? "" : " * $(factor(g))" + body *= " $target = $(to_pystatic(operator(g), subgraphs(g), subgraph_factors(g)))$factor_str\n" + push!(inds_visitednode, g_id) + end + if isroot + body *= " graph_list.append($target)\n" + end + end + end + tail = " return graph_list\n" + tail *= "output = graphfunc()" + expr = head * body * tail + # return head * body * tail + f = open("GraphFunc.py","w") + write(f,expr) +end + + +# function to_mindspore_graph(graphs::AbstractVector{<:AbstractGraph}) +# pyexpr = to_python_str_ms(graphs) +# py""" +# import mindspore as ms +# exec($pyexpr) +# ms_graph = jit(fn=graphfunc) +# out = ms_graph() +# """ +# return py"out" +# end + From 5e5917dee1a942ed20c052e36a6e09092f5d52ba Mon Sep 17 00:00:00 2001 From: Lizhiyi Date: Tue, 21 Nov 2023 15:08:41 +0800 Subject: [PATCH 06/11] add toMindspore.jl --- src/backend/compiler.jl | 2 + src/backend/toMindspore.jl | 122 +++++++++++++++++++++++++++++++++++++ 2 files changed, 124 insertions(+) create mode 100644 src/backend/toMindspore.jl diff --git a/src/backend/compiler.jl b/src/backend/compiler.jl index 6559b418..07192f00 100644 --- a/src/backend/compiler.jl +++ b/src/backend/compiler.jl @@ -1,4 +1,5 @@ module Compilers +using PyCall using ..ComputationalGraphs import ..ComputationalGraphs: id, name, set_name!, operator, subgraphs, subgraph_factors, factor @@ -8,5 +9,6 @@ using ..RuntimeGeneratedFunctions RuntimeGeneratedFunctions.init(Compilers) include("static.jl") +include("toMindspore.jl") end \ No newline at end of file diff --git a/src/backend/toMindspore.jl b/src/backend/toMindspore.jl new file mode 100644 index 00000000..c37e8bf1 --- /dev/null +++ b/src/backend/toMindspore.jl @@ -0,0 +1,122 @@ +# ms = pyimport("mindspore") + +""" + function to_pystatic(operator::Type, subgraphs::AbstractVector{<:AbstractGraph}, subgraph_factors::AbstractVector) + +Returns the static representation of a computational graph node `g` with operator `operator`, subgraphs `subgraphs`, and subgraph factors `subgraph_factors` in python. +""" +function to_pystatic(operator::Type, subgraphs::AbstractVector{<:AbstractGraph}, subgraph_factors::AbstractVector) + error( + "Static representation for computational graph nodes with operator $(operator) not yet implemented! " * + "Please define a method `to_static(::Type{$(operator)}, subgraphs::$(typeof(subgraphs)), subgraph_factors::$(typeof(subgraph_factors)))`." + ) +end + +function to_pystatic(::Type{ComputationalGraphs.Sum}, subgraphs::Vector{Graph{F,W}}, subgraph_factors::Vector{F}) where {F,W} + if length(subgraphs) == 1 + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "(g$(subgraphs[1].id)$factor_str)" + else + terms = ["g$(g.id)" * (gfactor == 1 ? "" : " * $gfactor") for (g, gfactor) in zip(subgraphs, subgraph_factors)] + return "(" * join(terms, " + ") * ")" + end +end + +function to_pystatic(::Type{ComputationalGraphs.Prod}, subgraphs::Vector{Graph{F,W}}, subgraph_factors::Vector{F}) where {F,W} + if length(subgraphs) == 1 + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "(g$(subgraphs[1].id)$factor_str)" + else + terms = ["g$(g.id)" * (gfactor == 1 ? "" : " * $gfactor") for (g, gfactor) in zip(subgraphs, subgraph_factors)] + return "(" * join(terms, " * ") * ")" + # return "(" * join(["g$(g.id)" for g in subgraphs], " * ") * ")" + end +end + +function to_pystatic(::Type{ComputationalGraphs.Power{N}}, subgraphs::Vector{Graph{F,W}}, subgraph_factors::Vector{F}) where {N,F,W} + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "((g$(subgraphs[1].id))**$N$factor_str)" +end + +function to_pystatic(::Type{ComputationalGraphs.Sum}, subgraphs::Vector{FeynmanGraph{F,W}}, subgraph_factors::Vector{F}) where {F,W} + if length(subgraphs) == 1 + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "(g$(subgraphs[1].id)$factor_str)" + else + terms = ["g$(g.id)" * (gfactor == 1 ? "" : " * $gfactor") for (g, gfactor) in zip(subgraphs, subgraph_factors)] + return "(" * join(terms, " + ") * ")" + end +end + +function to_pystatic(::Type{ComputationalGraphs.Prod}, subgraphs::Vector{FeynmanGraph{F,W}}, subgraph_factors::Vector{F}) where {F,W} + if length(subgraphs) == 1 + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "(g$(subgraphs[1].id)$factor_str)" + else + terms = ["g$(g.id)" * (gfactor == 1 ? "" : " * $gfactor") for (g, gfactor) in zip(subgraphs, subgraph_factors)] + return "(" * join(terms, " * ") * ")" + end +end + +function to_pystatic(::Type{ComputationalGraphs.Power{N}}, subgraphs::Vector{FeynmanGraph{F,W}}, subgraph_factors::Vector{F}) where {N,F,W} + factor_str = subgraph_factors[1] == 1 ? "" : " * $(subgraph_factors[1])" + return "((g$(subgraphs[1].id))**$N$factor_str)" +end + +""" + function to_julia_str(graphs::AbstractVector{<:AbstractGraph}) + +Compile a list of graphs into a string for a python static function and output a python script which support the static graph representation in mindspore framework. +""" + +function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) + head = "import mindspore as ms\n@ms.jit\n" + head *= "def graphfunc():\n" + body = " graph_list = []\n" + leafidx = 1 + root = [id(g) for g in graphs] + inds_visitedleaf = Int[] + inds_visitednode = Int[] + for graph in graphs + for g in PostOrderDFS(graph) #leaf first search + g_id = id(g) + target = "g$(g_id)" + isroot = false + if g_id in root + isroot = true + end + if isempty(subgraphs(g)) #leaf + g_id in inds_visitedleaf && continue + factor_str = factor(g) == 1 ? "" : " * $(factor(g))" + body *= " $target = ms.Tensor(1.0)$factor_str\n" + leafidx += 1 + push!(inds_visitedleaf, g_id) + else + g_id in inds_visitednode && continue + factor_str = factor(g) == 1 ? "" : " * $(factor(g))" + body *= " $target = $(to_pystatic(operator(g), subgraphs(g), subgraph_factors(g)))$factor_str\n" + push!(inds_visitednode, g_id) + end + if isroot + body *= " graph_list.append($target)\n" + end + end + end + tail = " return graph_list\n" + tail *= "output = graphfunc()" + expr = head * body * tail + # return head * body * tail + f = open("GraphFunc.py", "w") + write(f, expr) +end + +# function to_mindspore_graph(graphs::AbstractVector{<:AbstractGraph}) +# pyexpr = to_python_str_ms(graphs) +# py""" +# import mindspore as ms +# exec($pyexpr) +# ms_graph = jit(fn=graphfunc) +# out = ms_graph() +# """ +# return py"out" +# end From 46566ecd0a83c770ace99c1fb95a311441318708 Mon Sep 17 00:00:00 2001 From: Lizhiyi Date: Fri, 24 Nov 2023 22:23:02 +0800 Subject: [PATCH 07/11] update toMindspore.jl --- src/backend/toMindspore.jl | 10 +++++++--- 1 file changed, 7 insertions(+), 3 deletions(-) diff --git a/src/backend/toMindspore.jl b/src/backend/toMindspore.jl index c37e8bf1..b3c19f1c 100644 --- a/src/backend/toMindspore.jl +++ b/src/backend/toMindspore.jl @@ -71,7 +71,7 @@ Compile a list of graphs into a string for a python static function and output a function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) head = "import mindspore as ms\n@ms.jit\n" - head *= "def graphfunc():\n" + head *= "def graphfunc(leaf):\n" body = " graph_list = []\n" leafidx = 1 root = [id(g) for g in graphs] @@ -88,7 +88,7 @@ function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) if isempty(subgraphs(g)) #leaf g_id in inds_visitedleaf && continue factor_str = factor(g) == 1 ? "" : " * $(factor(g))" - body *= " $target = ms.Tensor(1.0)$factor_str\n" + body *= " $target = ms.Tensor(leaf[$(leafidx-1)])$factor_str\n" leafidx += 1 push!(inds_visitedleaf, g_id) else @@ -103,11 +103,15 @@ function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) end end tail = " return graph_list\n" - tail *= "output = graphfunc()" + tail*= "def to_StaticGraph(leaf)\n" + tail*= " output = graphfunc(leaf)\n" + tail*= " return output" expr = head * body * tail + println(expr) # return head * body * tail f = open("GraphFunc.py", "w") write(f, expr) + return expr end # function to_mindspore_graph(graphs::AbstractVector{<:AbstractGraph}) From b23453cf83ab93762983704d894310f4b94c3d4a Mon Sep 17 00:00:00 2001 From: Lizhiyi Date: Sat, 25 Nov 2023 00:45:58 +0800 Subject: [PATCH 08/11] fix bug --- src/backend/toMindspore.jl | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/backend/toMindspore.jl b/src/backend/toMindspore.jl index b3c19f1c..4df4ab48 100644 --- a/src/backend/toMindspore.jl +++ b/src/backend/toMindspore.jl @@ -103,7 +103,7 @@ function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) end end tail = " return graph_list\n" - tail*= "def to_StaticGraph(leaf)\n" + tail*= "def to_StaticGraph(leaf):\n" tail*= " output = graphfunc(leaf)\n" tail*= " return output" expr = head * body * tail From 4b3f75b4e5a9e208f7bb103b4e6b6b562b71fc88 Mon Sep 17 00:00:00 2001 From: Lizhiyi Date: Sat, 25 Nov 2023 03:05:25 +0800 Subject: [PATCH 09/11] refactor interface to mindspore for AD --- src/backend/toMindspore.jl | 24 ++++++++++++++++-------- 1 file changed, 16 insertions(+), 8 deletions(-) diff --git a/src/backend/toMindspore.jl b/src/backend/toMindspore.jl index 4df4ab48..99275a46 100644 --- a/src/backend/toMindspore.jl +++ b/src/backend/toMindspore.jl @@ -71,12 +71,14 @@ Compile a list of graphs into a string for a python static function and output a function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) head = "import mindspore as ms\n@ms.jit\n" - head *= "def graphfunc(leaf):\n" - body = " graph_list = []\n" + # head *= "def graphfunc(leaf):\n" + # body = " graph_list = []\n" + body = "" leafidx = 1 root = [id(g) for g in graphs] inds_visitedleaf = Int[] inds_visitednode = Int[] + rootidx = 1 for graph in graphs for g in PostOrderDFS(graph) #leaf first search g_id = id(g) @@ -88,7 +90,7 @@ function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) if isempty(subgraphs(g)) #leaf g_id in inds_visitedleaf && continue factor_str = factor(g) == 1 ? "" : " * $(factor(g))" - body *= " $target = ms.Tensor(leaf[$(leafidx-1)])$factor_str\n" + body *= " $target = l$(leafidx)$factor_str\n" leafidx += 1 push!(inds_visitedleaf, g_id) else @@ -98,14 +100,20 @@ function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) push!(inds_visitednode, g_id) end if isroot - body *= " graph_list.append($target)\n" + body *= " out$(rootidx)=$target\n" + rootidx +=1 end end end - tail = " return graph_list\n" - tail*= "def to_StaticGraph(leaf):\n" - tail*= " output = graphfunc(leaf)\n" - tail*= " return output" + input = ["l$(i)" for i in 1:leafidx-1] + input = join(input,",") + output = ["out$(i)" for i in 1:rootidx-1] + output = join(output,",") + head *="def graphfunc($input)\n" + tail = " return $output\n" + # tail*= "def to_StaticGraph(leaf):\n" + # tail*= " output = graphfunc(leaf)\n" + # tail*= " return output" expr = head * body * tail println(expr) # return head * body * tail From 8111fc9f38bcaf50bd92342e9ec3b0e1b9819b93 Mon Sep 17 00:00:00 2001 From: Lizhiyi Date: Sat, 25 Nov 2023 03:14:42 +0800 Subject: [PATCH 10/11] fix bug --- src/backend/toMindspore.jl | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/backend/toMindspore.jl b/src/backend/toMindspore.jl index 99275a46..a4e540f9 100644 --- a/src/backend/toMindspore.jl +++ b/src/backend/toMindspore.jl @@ -109,7 +109,7 @@ function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) input = join(input,",") output = ["out$(i)" for i in 1:rootidx-1] output = join(output,",") - head *="def graphfunc($input)\n" + head *="def graphfunc($input):\n" tail = " return $output\n" # tail*= "def to_StaticGraph(leaf):\n" # tail*= " output = graphfunc(leaf)\n" From 13c06f6ea0bf99300cc6ae1cb376023684e1e2e3 Mon Sep 17 00:00:00 2001 From: ZhiyiLi Date: Thu, 30 Nov 2023 11:30:11 +0800 Subject: [PATCH 11/11] add a dict mapping the graph_id to the leaf_id --- src/backend/toMindspore.jl | 15 +++------------ 1 file changed, 3 insertions(+), 12 deletions(-) diff --git a/src/backend/toMindspore.jl b/src/backend/toMindspore.jl index a4e540f9..ae9643c7 100644 --- a/src/backend/toMindspore.jl +++ b/src/backend/toMindspore.jl @@ -68,7 +68,6 @@ end Compile a list of graphs into a string for a python static function and output a python script which support the static graph representation in mindspore framework. """ - function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) head = "import mindspore as ms\n@ms.jit\n" # head *= "def graphfunc(leaf):\n" @@ -78,6 +77,7 @@ function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) root = [id(g) for g in graphs] inds_visitedleaf = Int[] inds_visitednode = Int[] + gid_to_leafid = Dict{String, Int64}() rootidx = 1 for graph in graphs for g in PostOrderDFS(graph) #leaf first search @@ -91,6 +91,7 @@ function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) g_id in inds_visitedleaf && continue factor_str = factor(g) == 1 ? "" : " * $(factor(g))" body *= " $target = l$(leafidx)$factor_str\n" + gid_to_leafid[target] = leafidx leafidx += 1 push!(inds_visitedleaf, g_id) else @@ -119,16 +120,6 @@ function to_python_str_ms(graphs::AbstractVector{<:AbstractGraph}) # return head * body * tail f = open("GraphFunc.py", "w") write(f, expr) - return expr + return expr, leafidx-1, gid_to_leafid end -# function to_mindspore_graph(graphs::AbstractVector{<:AbstractGraph}) -# pyexpr = to_python_str_ms(graphs) -# py""" -# import mindspore as ms -# exec($pyexpr) -# ms_graph = jit(fn=graphfunc) -# out = ms_graph() -# """ -# return py"out" -# end