From 938821bda3fd21ac9d0105ee5c01199a488d3405 Mon Sep 17 00:00:00 2001 From: Ph0non Date: Sun, 19 Feb 2017 23:28:57 +0100 Subject: [PATCH] Remove deprecated folder --- deprecated/NuclideVector_v4.3.jl | 401 ------------------ deprecated/nvdb-v2.sqlite | Bin 36864 -> 0 bytes deprecated/settings/A01_fma_2050_2070.txt | 37 -- .../settings/A01_fma_2050_2070_Co60.txt | 37 -- deprecated/settings/A01_fmais_2016_2026.txt | 44 -- deprecated/settings/A01_fmais_2050_2070.txt | 37 -- deprecated/settings/A01_is_2016_2026.txt | 39 -- deprecated/settings/A02_fma_2050_2070.txt | 41 -- deprecated/settings/A04_fma_2050_2070.txt | 42 -- deprecated/settings/A04_fmais_2016_2026.txt | 41 -- deprecated/settings/A05_fma_2050_2070.txt | 41 -- deprecated/settings/A05_fmais_2016_2026.txt | 40 -- deprecated/settings/A06_fma_2050_2070.txt | 41 -- deprecated/settings/A06_fmabis_2016_2026.txt | 38 -- deprecated/settings/A07_fmabis_2016_2026.txt | 39 -- deprecated/settings/A08_fma_2050_2070.txt | 41 -- deprecated/settings/A08_fmabis_2016_2026.txt | 42 -- deprecated/settings/A10_fma_fmb_is.jld | Bin 17578 -> 0 bytes deprecated/settings/A10_fma_is.jld | Bin 17826 -> 0 bytes deprecated/settings/A10_fmb.jld | Bin 17810 -> 0 bytes deprecated/settings/B01_fma_2050_2070.txt | 39 -- .../settings/B01_fma_2050_2070_Co60.txt | 36 -- deprecated/settings/C01_fma_2050_2070.txt | 40 -- deprecated/settings/D01_fma_2050.txt | 39 -- deprecated/settings/D01_fma_2050_2070.txt | 39 -- deprecated/settings/D01_fma_2070.txt | 36 -- deprecated/settings/KWO_fma_2016_2018.txt | 39 -- deprecated/settings/NV2_fma_2050.txt | 40 -- deprecated/settings/NV2_fma_2070.txt | 40 -- deprecated/settings/NV3_fma_2050_2070.txt | 41 -- deprecated/settings/NV4_fma_2050.txt | 44 -- deprecated/settings/NV4_fma_2070.txt | 42 -- deprecated/settings/NVA_fma_2050.txt | 41 -- deprecated/settings/NVA_fma_2070.txt | 40 -- deprecated/settings/settings.yaml | 44 -- deprecated/settings/test_A07_aufK2.yaml | 27 -- deprecated/settings/test_FILTER.txt | 27 -- deprecated/settings/test_KWO.txt | 27 -- deprecated/test/A01_2016.txt | 27 -- deprecated/test/A08_2016.txt | 28 -- 40 files changed, 1737 deletions(-) delete mode 100644 deprecated/NuclideVector_v4.3.jl delete mode 100644 deprecated/nvdb-v2.sqlite delete mode 100644 deprecated/settings/A01_fma_2050_2070.txt delete mode 100644 deprecated/settings/A01_fma_2050_2070_Co60.txt delete mode 100644 deprecated/settings/A01_fmais_2016_2026.txt delete mode 100644 deprecated/settings/A01_fmais_2050_2070.txt delete mode 100644 deprecated/settings/A01_is_2016_2026.txt delete mode 100644 deprecated/settings/A02_fma_2050_2070.txt delete mode 100644 deprecated/settings/A04_fma_2050_2070.txt delete mode 100644 deprecated/settings/A04_fmais_2016_2026.txt delete mode 100644 deprecated/settings/A05_fma_2050_2070.txt delete mode 100644 deprecated/settings/A05_fmais_2016_2026.txt delete mode 100644 deprecated/settings/A06_fma_2050_2070.txt delete mode 100644 deprecated/settings/A06_fmabis_2016_2026.txt delete mode 100644 deprecated/settings/A07_fmabis_2016_2026.txt delete mode 100644 deprecated/settings/A08_fma_2050_2070.txt delete mode 100644 deprecated/settings/A08_fmabis_2016_2026.txt delete mode 100644 deprecated/settings/A10_fma_fmb_is.jld delete mode 100644 deprecated/settings/A10_fma_is.jld delete mode 100644 deprecated/settings/A10_fmb.jld delete mode 100644 deprecated/settings/B01_fma_2050_2070.txt delete mode 100644 deprecated/settings/B01_fma_2050_2070_Co60.txt delete mode 100644 deprecated/settings/C01_fma_2050_2070.txt delete mode 100644 deprecated/settings/D01_fma_2050.txt delete mode 100644 deprecated/settings/D01_fma_2050_2070.txt delete mode 100644 deprecated/settings/D01_fma_2070.txt delete mode 100644 deprecated/settings/KWO_fma_2016_2018.txt delete mode 100644 deprecated/settings/NV2_fma_2050.txt delete mode 100644 deprecated/settings/NV2_fma_2070.txt delete mode 100644 deprecated/settings/NV3_fma_2050_2070.txt delete mode 100644 deprecated/settings/NV4_fma_2050.txt delete mode 100644 deprecated/settings/NV4_fma_2070.txt delete mode 100644 deprecated/settings/NVA_fma_2050.txt delete mode 100644 deprecated/settings/NVA_fma_2070.txt delete mode 100644 deprecated/settings/settings.yaml delete mode 100644 deprecated/settings/test_A07_aufK2.yaml delete mode 100644 deprecated/settings/test_FILTER.txt delete mode 100644 deprecated/settings/test_KWO.txt delete mode 100644 deprecated/test/A01_2016.txt delete mode 100644 deprecated/test/A08_2016.txt diff --git a/deprecated/NuclideVector_v4.3.jl b/deprecated/NuclideVector_v4.3.jl deleted file mode 100644 index e66166d..0000000 --- a/deprecated/NuclideVector_v4.3.jl +++ /dev/null @@ -1,401 +0,0 @@ -####################################################### -# load modules -using SQLite -using NamedArrays -using JuMP -using Cbc -using YAML -using ProgressMeter - -####################################################### -# helper functions - -function travec(x::Array{Date,1}) - reshape(x, 1, length(x)) -end - -function nable2arr(x) - (el_i,el_j) = size(x) - y = Array{ typeof(x[1,1].value) }(el_i, el_j) - for j=1:el_j - for i=1:el_i - y[i, j] = x[i, j].value - end - end - return y -end - -function fill_wzero(x) - (el_i,el_j) = size(x) - y = Array{ Nullable{Float64} }(el_i, el_j) - for j=1:el_j - for i=1:el_i - if isnull(x[i, j]) - y[i, j] = 0 - else - y[i, j] = x[i, j].value - end - end - end - return y -end - -function arr2str(nn::Array{String, 1}) - nn_str = nn[1] - for i=2:length(nn) - nn_str *= ", " * nn[i] - end - return nn_str -end - -# function schema2arr(x::DataStreams.Data.Table) -# y = Array(Any, x.schema.rows, x.schema.cols) -# for i=1:x.schema.cols -# y[:,i] = x.data[i].values -# end -# return y -# end -function schema2arr(x::DataFrames.DataFrame) - y = Array(x) -end - -function schema2arr(x::NullableArrays.NullableArray) - y = Array(x) -end - -# read db table with first column as Named Array dimnames -function read_db(nvdb::SQLite.DB, tab::String) - val = SQLite.query(nvdb, "select * from " * tab); - val_data = schema2arr(val)[:,2:end] - - #nu_name = val.schema.header[2:end] - nu_name = Data.schema(val[2:end]).header - #path_names = val.data[1].values - path_names = [val[1][i].value for i=1:size(val, 1) ] - NamedArray(val_data, (path_names, nu_name), ("path", "nuclides")) -end - -function get_years() - if "years" in keys(settings) - ifelse - collect(settings["years"][1] : settings["years"][2]) - else - [settings["year"], settings["year"] + 1] - end -end - -reduce_factor(q) = q[:, convert(Array{String, 1}, rel_nuclides)] - -function get_rel_nuclides_and_weights() - el = length(settings["nuclides"]) - rel_nuclides_tmp = Array(String, el) - mean_weight_tmp = ones(el) - spl_string = map( x -> split(x), settings["nuclides"] ) - for i = 1 : el - rel_nuclides_tmp[i] = spl_string[i][1] - if checkbounds(Bool, spl_string[i], 2) - mean_weight_tmp[i] = parse(Float64, spl_string[i][2]) - end - end - return (rel_nuclides_tmp, mean_weight_tmp) -end - -function del_zero_from_table() - for i in nuclide_names - SQLite.query(nvdb, "update `nv_data` set " * i *" = null where " * i * " = 0") - end -end - -function get_sample_info(x::String) - nable2arr( schema2arr( SQLite.query(nvdb, "select " * x * " from nv_data join nv_summary on nv_data.nv_id = nv_summary.nv_id where NV = '" * settings["nv_name"] *"'") ) ) -end - -####################################################### -# decay correction - -function decay_correction(nvdb::SQLite.DB, nuclide_names::Array{String, 1}, years::Array{Int64,1}) - hl_raw = SQLite.query(nvdb, "select " * arr2str(nuclide_names) * " from halflife"); - hl = NamedArray(schema2arr(hl_raw), ([1], nuclide_names), ("halftime", "nuclides")) - ## Workaround Typänderung SQLite - hl = NamedArray(convert(Array{Float64, 2}, [hl.array[i].value for i = 1:length(hl) ]'), ([1], nuclide_names), ("halftime", "nuclides") ) - - sample_date = map(x->Date(x, "dd.mm.yyyy"), get_sample_info("date") ) - sample_id = get_sample_info("s_id") |> vec - - samples_raw = SQLite.query(nvdb, "select " * arr2str(nuclide_names) * " from nv_data join nv_summary on nv_data.nv_id = nv_summary.nv_id where NV = '" * settings["nv_name"] *"'") |> fill_wzero |> nable2arr - - samples = NamedArray( samples_raw, (sample_id, nuclide_names), ("samples", "nuclides")) - - if settings["use_decay_correction"] == true - ref_date = settings["ref_date"] - date_format = Dates.DateFormat("d u"); - (month_, day_) = Dates.monthday(Dates.DateTime(ref_date, date_format)) - - tday_raw = travec([Date(years[1], month_, day_):Dates.Year(1):Date(years[end], month_, day_);]) .- sample_date; # calculate difference in days - tday = NamedArray(convert(Array{Int64,2}, tday_raw), (NamedArrays.names(samples, 1), years), ("samples", "years") ) - else - tday = NamedArray(zeros(size(sample_view, 1), length(years) ), (NamedArrays.names(samples, 1), years), ("samples", "years") ) - end - - samples_korr = NamedArray(Array(Float64, size(tday,1), size(samples,2), size(tday,2)), - (NamedArrays.names(samples, 1), nuclide_names, years), - ("samples", "nuclides", "year") ); - for i in years - samples_korr[:,:,i] = samples.array .* 2.^(-tday[:,i].array ./ hl); - # Am241 and Pu241 must be in sample nuclide_names - samples_korr[:,"Am241",i] = Array(samples_korr[:,"Am241",i]) + Array(samples[:, "Pu241"]) .* hl[1,"Pu241"]./(hl[1,"Pu241"] - hl[1,"Am241"]) .* - (2.^(-tday[:,i].array ./ hl[1,"Pu241"]) - 2.^(-tday[:,i].array ./ hl[1,"Am241"])) - end - - return samples_korr -end - -####################################################### -# relevant nuclides and calculations - -function nuclide_parts(samples_korr::NamedArrays.NamedArray{Float64,3,Array{Float64,3}, - Tuple{DataStructures.OrderedDict{Int64,Int64}, - DataStructures.OrderedDict{String,Int64}, - DataStructures.OrderedDict{Int64,Int64}}}) - NamedArray( samples_korr./sum(samples_korr,2), samples_korr.dicts, samples_korr.dimnames) -end - -function nuclide_parts(sf::AbstractString) - global settings = YAML.load(open(sf)); - global rel_nuclides = get_rel_nuclides_and_weights()[1] - global nvdb = SQLite.DB(settings["db_name"]); - global nuclide_names = convert(Array{String,1}, SQLite.query(nvdb, "pragma table_info(halflife)")[:,2]); - samples_korr = decay_correction(nvdb, nuclide_names, get_years() ) - NamedArray( samples_korr./sum(samples_korr,2), samples_korr.dicts, samples_korr.dimnames) -end - -function calc_factors(samples_part::NamedArrays.NamedArray{Float64,3,Array{Float64,3}, - Tuple{DataStructures.OrderedDict{Int64,Int64}, - DataStructures.OrderedDict{String,Int64}, - DataStructures.OrderedDict{Int64,Int64}}}) - #specific = read_setting(:specific, sf) - clearance_val = read_db(nvdb, "clearance_val"); - - ɛ = read_db(nvdb, "efficiency"); - f = NamedArray( 1./nable2arr(clearance_val), clearance_val.dicts, clearance_val.dimnames); - - A = NamedArray(Array(Float64, size(samples_part,1), size(clearance_val,1), size(samples_part,3)), - (names(samples_part)[1], names(clearance_val)[1], get_years()), - ("sample", "path", "years")); # path -> clearance path - ∑Co60Eq = NamedArray(Array(Float64, size(samples_part,1), size(ɛ,1), size(samples_part,3)), - (names(samples_part)[1], names(ɛ)[1], get_years()), - ("sample", "path", "years")); # path -> fma / fmb / is - - (fᵀ = f'; ɛᵀ = nable2arr(ɛ)'); - for i in get_years() - A[:,:,i] = samples_part[:,:,i].array * fᵀ - ∑Co60Eq[:,:,i] = samples_part[:,:,i].array * ɛᵀ # sum of Co60-equiv. also contain non measureable nuclides - end - a = 1./A; - - return a, ∑Co60Eq, f, ɛ -end - -####################################################### -# solve problem - -function get_nv(sf::AbstractString) - global settings = YAML.load(open(sf)); - (rel_nuclides, mean_weight) = get_rel_nuclides_and_weights() - global rel_nuclides = rel_nuclides - global nvdb = SQLite.DB(settings["db_name"]); - global nuclide_names = convert(Array{String,1}, SQLite.query(nvdb, "pragma table_info(halflife)")[:,2]); - - np = decay_correction(nvdb, nuclide_names, get_years() ) |> nuclide_parts - a, ∑Co60Eq, f, ɛ = np |> calc_factors - - (nv = Array(Float64, length(rel_nuclides), size(a,3)-1); i = 1); -# @showprogress -# @progress ["Jahr"] -for l in get_years()[1:end-1] # year =1:length(get_years())-1 - (nv[:, i] = solve_nv( l, a, ∑Co60Eq, reduce_factor(f), reduce_factor(ɛ), np[:,:,l:l+1], mean_weight ); i += 1); - end - write_result(nv) -end - -function determine_list_∑Co60Eq() - fmx = Array(Array{Any,1}, 3) - list_∑Co60Eq = Array(Int, 0) - index = settings["clearance_paths"][1] - - for i in ["fma", "fmb", "is"] - if !isempty( find(i .== settings["use_co60eq"]) ) - ind = find(i .== ["fma", "fmb", "is"])[1] - fmx[ ind ] = index[i]; - push!(list_∑Co60Eq, ind) - end - end - if !isassigned(fmx, 1) && !isassigned(fmx, 2) && !isassigned(fmx, 3) - error("expected 'fma', 'fmb' or 'is' in a list in option 'use_co60eq'") - end - - return fmx, list_∑Co60Eq -end - -function add_user_constraints(m::JuMP.Model, x::Array{JuMP.Variable,1}) - for constr in settings["constraints"] - constr_tmp = split(constr) - index = find(rel_nuclides .== constr_tmp[1])[1] - rhs = float(constr_tmp[3]) * 100 - if constr_tmp[2] == "<=" - @constraint(m, x[index] <= rhs) - elseif constr_tmp[2] == ">=" - @constraint(m, x[index] >= rhs) - elseif (constr_tmp[2] == "==") | (constr_tmp[2] == "=") - @constraint(m, x[index] == rhs) - else - error("expected comparison operator (<=, >=, or ==) for constraints") - end - end -end - -function solve_nv{ T1<:NamedArrays.NamedArray{Float64,3,Array{Float64,3}, - Tuple{DataStructures.OrderedDict{Int64,Int64}, - DataStructures.OrderedDict{String,Int64}, - DataStructures.OrderedDict{Int64,Int64}}}, - T2<:NamedArrays.NamedArray{Float64,2,Array{Float64,2}, - Tuple{DataStructures.OrderedDict{String,Int64}, - DataStructures.OrderedDict{String,Int64}}}, - T3<:NamedArrays.NamedArray{Nullable,2,Array{Nullable,2}, - Tuple{DataStructures.OrderedDict{String,Int64}, - DataStructures.OrderedDict{String,Int64}}} }( - l::Int, a::T1, ∑Co60Eq::T1, f_red::T2, ɛ_red::T3, np::T1, mean_weight::Vector{Float64} ) - ɛ_red = nable2arr(ɛ_red); - m=Model(solver = CbcSolver()); - @variable(m, 0 ≤ x[1:length(rel_nuclides)] ≤ 10_000, Int); - #@objective(m, :Min, -sum( x[ find(rel_nuclides .== "Co60") | find(rel_nuclides .== "Cs137")]) ); - - # set objectives - if settings["ot"] == "measure" - if haskey(settings, "co60_weight") - co60_weight = settings["co60_weight"] - else - co60_weight = 1 - end - @objective(m, :Min, - co60_weight * x[ find(rel_nuclides .== "Co60")][1] - -x[ find(rel_nuclides .== "Cs137")][1] ); - elseif settings["ot"] in keys(read_db(nvdb, "clearance_val").dicts[1]) - @objective(m, :Min, sum(x .* f_red[settings["ot"], :]) ); - elseif settings["ot"] == "mean" - np_red = mean( mean( np, 3)[:,:,1], 1)[:, rel_nuclides] - obj_tmp = x - 10_000 * np_red.array' - - @variable(m, z[1:length(rel_nuclides)] ) - for i = 1:length(rel_nuclides) - @constraint(m, z[i] >= obj_tmp[i] ) - @constraint(m, z[i] >= -obj_tmp[i] ) - end - @objective(m, :Min, sum(z .* mean_weight) ) - else - error("expected 'measure', 'mean' or clearance path for optimization target") - end - @constraint(m, sum(x) == 10_000); - - # add user constraints - if typeof(settings["constraints"]) != Void - add_user_constraints(m, x) - end - - # Co60-equiv for nv - @expression(m, Co60eqnv[p=1:3], sum(ɛ_red[p,i] * x[i] for i = 1:length(rel_nuclides) if ɛ_red[p,i] != 0)) - - # determine fma / fmb / is - fmx, list_∑Co60Eq = determine_list_∑Co60Eq() - - for r in list_∑Co60Eq - # lower bound - @constraint(m, constr_lb[k in fmx[r], j in keys(a.dicts[1]), h=0:1], Co60eqnv[r] ≤ ∑Co60Eq[j,r,l+h] * a[j,k,l+h] * sum(f_red[k,i] * x[i] for i=1:length(rel_nuclides) ) ) - # upper bound - if settings["use_upper_bound"] - @constraint(m, constr_ub[k in fmx[r], j in keys(a.dicts[1]), h=0:1], ∑Co60Eq[j,r,l+h] * a[j,k,l+h] * sum(f_red[k,i] * x[i] for i=1:length(rel_nuclides) ) ≤ settings["upper_bound"] * Co60eqnv[r] ) - end - end - - sstatus = solve(m, suppress_warnings=true); - - if (sstatus == :Infeasible) - print_with_color(:red, string(l) * " no solution in given bounds\n") - return zeros(length(x)) - elseif sstatus == :Optimal - #print_with_color(:green, string(l) * " solution found.\n") - return round(getvalue(x)./100, 2) - else - print("Something weird happen! sstatus = " * string(sstatus) *"\n") - return zeros(length(x)) - end - -end - -function write_result(nv::Array{Float64,2}) - NamedArray( nv, (rel_nuclides, get_years()[1:end-1]), ("nuclides", "years")) - #writetable(nv_name * "/" * string(get_years()[l]) * "_" * clearance_paths * ".csv", nv, separator=';') -end - -####################################################### -# test NV - -function test_nv(tf::AbstractString) - global settings = YAML.load(open(tf)); - global nvdb = SQLite.DB(settings["db_name"]); - global nuclide_names = convert(Array{String,1}, SQLite.query(nvdb, "pragma table_info(halflife)")[:,2]); - - a, ∑Co60Eq, f, ɛ = decay_correction(nvdb, nuclide_names, get_years() ) |> nuclide_parts |> calc_factors - - full_list_nv = get_pre_nv() - - f_nv = f * full_list_nv - ɛ_nv = nable2arr(ɛ) * full_list_nv - - fmx, list_∑Co60Eq = determine_list_∑Co60Eq() - - for r in list_∑Co60Eq - for l in get_years() - print_with_color(:green, string(names(ɛ)[1][r]) * ", " * string(l) * "\n") - println( print_ratio(∑Co60Eq, a, f_nv, ɛ_nv, l, r, fmx) ) - end - end -end - -function print_ratio(∑Co60Eq, a, f_nv, ɛ_nv, l, r, fmx) - ratio = NamedArray(Array(Float64, length(fmx[r]), size(a, 1)), - (fmx[r], names(a)[1]), - ("path", "sample")); - - for j = 1:size(a, 1) - i = 1 - for k in fmx[r] - ratio[i, j] = ∑Co60Eq[j,r,l] * a[j,k,l] * f_nv[k] ./ ɛ_nv[r] - i += 1 - end - end - writedlm("OUTPUT.csv", ratio) - ratio, 1 .<= ratio -end - -function get_pre_nv() - full_list_nv = zeros( length(nuclide_names), 1) - for nv in settings["nuclide_vector"] - nv_tmp = split(nv) - full_list_nv[ find(nuclide_names .== nv_tmp[1])[1] ] = float(nv_tmp[3]) * 100 - # rhs = float(nv_tmp[3]) * 100 - end - if sum(full_list_nv) != 10_000 - error("Nuclide vector sum is not 1!") - end - return full_list_nv -end - -# Juno specific parts - -# Juno.@render Juno.Inline x::NamedArray begin -# Juno.Table(x) -# end - -function get_nv() - get_nv("settings/" * selector(readdir(pwd() * "/settings")) ) -end diff --git a/deprecated/nvdb-v2.sqlite b/deprecated/nvdb-v2.sqlite deleted file mode 100644 index 2d39facba1cd0e04223766630e7ce47306ba445e..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 36864 zcmeG_2VhiHwy#WPl1V}ml8}UiWI_#)GBfFd+!r9UgisQShzk>D0x=(3H<91|LBN^8yhv?s)pQu-|ZzzeuNRhzpQ`7 zzY{4h-}m(+&yP^x2nGIg6tLT3p)*wkW?jvdAo37L0KdGA!^KObTv%CP7Bk173^y<)sNW(^c6SAXm_HeK=DnxR^ZzPP%L z>%UF^tD=9R@6~t0&5`2>1&&bQe+va-ZMJkJp=Hq=zpv9*UKX$0vPH9_YvDp)`%-UV zoCZ(g0u2p~^BMy!^OkyJRa+k=Zh^14p}Dak;NkkOYac4QPfvu)k>dyj{tr{2pPro% z)$NE3KN>r#wd_PkWE4Jjh%0#f(62QttT(hpgX$MG#jsD|+Wu7=yI|9>#KCW??A|k8 zxP0Aqg?)bc882Lwzr@T?;dPEE5jD^$^j&b@u+Ya|o*7?1@##<5d2i0GIHR3_cKowzU9XXh_yzt!~+dveGn?rpIjun*z}{iWdj z8SL5JE9aaPGm<_0+ItzJa{t73J}_|A<>RNay>aJV_?L?xVgLB-o9yrM$FseX&9VAE zB~!aa)j!ui(r(dT)}PTI*B{Wg=(pzC-i*H`GRU>j=nO1)Gctf%We^(bA@{-u4W zy{YZdp3t^ycm5w1m?NnDmMGxRbv041aC@RNbu~S!!sDLP66kXDfv1_!=#inT*?q>0 zudb_{ItRYxNQVzHs%A`b^oE=CW8g^|-1M$+7duknCauC<8 za>w+5Ru9?ol*hzED;8U2F)`4J!B%NZG_<0zRpM|0P|lj^6^}ilHbE$nr{=dPTEfzAc3e(|E*i7mxN zF6g&9cT{U}DczO0<=w27l45yRQ(unXo7&}Zm&k_|^F8jeh1R{tjrXW%506 zhrgKI$r4XLau3;wR6|r|N6C0{7Ry(m#Vd!29|>{WXXLUeI?zM&MEXLH)1#J^CFG5!|F- zr(dmKreCE0K|fpmh&2Dm^#}!yP~g{4pr6Sn*ZQu6Q}$9gxjNvK)e5JKCODKD-X;p3DHyCY@LAa%`RVX@~m2Yl_mmU)3Wi+s&tji@l&-8byB zzOEc+)Z8{-=YqLW+|%bmi`(?MQNl?>i~H%&R*5^<;{H0=;yydr5`H__l)gKx4gNdW z7Ct=K6n;Fs83Kjy=OLeRpB`)qzaHM~_Gt*v+{XvMTLXSR*y6rE*aF8J@)~HBg?$$C z7Vhh%?+<=M`2VnGktf)!;Bi2(DPn=}W=PjOCJ25wE(Bm68^}+bgI5KhDi(9+{i}VdHn? z(<2o4zeRyQ!vEW$%txQ5-L8JC&Q+cYtN9V=nnUaZ)F}06h$0;Dfd7-VKa|dN@JEVb zw^#WVHnw?)b()Y*&w7`riP z**}ba;vEXx#pgT=3)#&#M|uXnvy|QRr`K!$wR1OX_}G5--S_;BUGvF?ul6d-v!z{_eV1y;ET-{e5;CpR^u-kC~+r(452FND5#hhc)fTfv&W~2PspXrfxKnkxCnj*@+*V zzrYej|1vJC%h^sov7dQ2LmsCZD*oVag6d8)M;!pO4512h5Lr2CejGkSz{WoObMruQ=nh~%0rtA5LgTnKyfAIa7Af4F{rReu*U;#!Cfralf+2RAC*i{Q;h_9 z*Nfc-GJNTuUbi%noC8vlJtmz9**lA1y&{7Ild>b7fv|7DGXyMB(+Dt&V8w1Am;}v8 zLOvm#mKX_AaN^jl=zRzvx<15B-9NXpJ5e3CN|H0AoN0FeU{N6=4Wn>=ga9U*2f^j` zhQOsuF!VMu?6K^&ydKkSsTUkXsdebE&`q+7B`c-=k5u$lZI?1q%T>=;-WGuTFA;mc+1I3VH(~ zk6KZIugLc9gtL;_gJ}NH92$v|G7;pM&4E3CKtu(c0?M9R3_|Jkc!h`-fe?7yLPX=N z?lCj~Uy&ibTQ1unyz&Wb1Nc5IW&*nzIZkm48DetP(nCAhU1*R=GEx%`4X7rKoz!y3 z?r6~jsJmS1QV`G>GBHN9q(jUb%E_rrDp4KVi0VuJ3>_|8y3;YI^=Vgk|HhVlJ$YQO zj~!dT5cBKuT*A;w<`+;IK!8 zub;|ZkwmlIn&OXUq)nG$+%+A8Q<7K|hB(qoc89bFW{+47TZrBxY#dO2aB$&>)f@yH zxH2h-p%$FHIM_rU94p(b5QKP3!BlsmnNQUW+fjT2#S2pZFHm$-drWImKUHTc7YGRc zdna>bDyLCxHkc4j78PnI1T-4AC(_aK2dR2O&G_-Tu8R7m=Ej!!^?`X!ftIH2TNgBU zEbZtFEX;M)&ZsEj4#u1BDK9TJBBVE2X$>*Hm1aGP%(>xRB|BPBWvMf{yiPPQ7>LpM zh3&^k`?fnbu9)6@fT5b3DJdL@DcPzp><+k>o=4L->=vt2^!S<|#lZ_PjKm=!YA(h6 zkrB4EB&R;x(pL293=NA>AaGIGo^oDVvWq<{97EUQUL3H&*%|-_AX$Lv2pDQdFTIDL z?&PX!K}e4m2w5lysrK!1_f8(}$W*rEG|VLHY}h3=>Dq4ef?*xR%j~Vns~@{>bNeW52Is<*mSZnVH_<${j|Hi-umt=wmov*O^60{QZMKY&8BZOP7LT zBjhMakKq)z@bY+xxW*uffwqdhBSpo+O~LWgTk;!fYZiN+k6OoWWD77RYQs^?1L%Nv z^6}x!cq0=dfgOCr_1OLFgs<3juYA3X?Gd{B_Z5i}YGQ|A3b3V{oFwYeVNeG}LVdt@ zLtc(@R(w*5OLrNAB&5awY50x)5))%=hj?J*;`1y%rh4yGuKzaWIz=zjI@Pn`<~Mnm z{)~aZTXU3Pt^g6D3VsBcE956bPvK2IE zc`e%*YT$e8i5$yuzD2(F#z1{*dtO0pTYFvhEc6B(pD21#tYA zrdO$H>?^4UYze9_UH^q@{fQh`8>0paPO}3T&Y{|ym1!IY?xeW20pre%3uK!>ZxIJ! zZPN6fKgCIbV4;)Z({gYG2d8OAQxIV!OPIA)%Ig&1F%mUOhdqEJr3a+w8QI9I7a?=< zyJE)Xk9ud`o^eg=LFpB^{zoX4iXNxcsi!K>!|l&M%(!e$jQQYGbTsNRFqEcUh1C*5 zJG1o+&d_S`)CVge1Ua+1Kye#80)dv!`99E5ZwZk_+p65O*Q?y9_rG<<8^);pf)Lrp z5F|)%qdbk{xsJ@8In*T~lI|DSqe_T^>=6*T^z@$xk>!bxcHCx5nxdv=eheb_qR1YU zTIqwe7%ZUDSdr~ObR)a@Fu(UzY>&v+^)supB(z+Zr00^(u$y(u($jtxv@jqbvC5W| zQZ`%aVM9j|B?ZJ7Ag|gBb?iB5+}J6I2AQ$V*v27?fx}O>4aXCd^DN60W~>sFLn^jV z4vAT)bY<$PLOK3T<{H8kM4w`XzU0`Ao)Sf4v=k)+)y{0`V}UNB2qo&!wyBTa>)#2w zCuk7*OFn5m$plj_I^ABPJYi*pyW0U8B#ETBf0hx4NmSzDhO^tF~4zLF&5kI{JV zV>HPmb`u8jUKWaw8zhgLVbM`AloI_7)UyTarUn{Y8s~Sl%6s-cD5m^X$!E%OoJ*rRc#VsI`=PN!8oBPE`;d=LCXQUi<9hU;1Y}+l^uiP zX;7p)BYWFsuZ@^x#LIYHf~%23{3C{-v=P_WPpIJzn=Mv zVM}+cqTrjRRH%F17$8L^@j9*E8uy|}llx<^3OUHta}I(PCNR1=GUe}N_>By7);O`6rp5U! zLqy{Zy3!OP8Y81Oj!j?0^!X^&e@c&(-V7(c%t1p5W=>bG)!$IMgh%!Z?K1%9;vZ7DW)~c_miY-?W@a9h@q47GBe6@y{SrQDmvh!mYjB1)!E#o zqY|2VUJmehGz6RpXb5DYO$^E4p;yo6H2Z#dA<>V7ByXdfMiFy_a=Vc(C6sNsAbRgB zPoKdW14DOh_a(CW=Q~m%Np4L`P=1&u_%?molYfJzwvYF4aEF1oN-&AQL}!iw93DMS z(zmLrIza^~Lo> zdN|^o+HPgXu~W)|^owvRn<+zSO&1dP-bFKmcEHF%YQBx>5;RL@VF8EOLlA?yAvePz zF3^Vx@`T%U3tA&yin_X!=E7-=H zN|wc)cad3`9|kpmEUiOu$SK&HuMavH>Y#-uJyGi{s1c7S1MQ@~QrSb|X&FX>`VLXD z(7|r!*~a@;8%}9_Eh!mO(5po`=Tdf;Tt_I!{{cmxr|r-p)m+6|%Ogebu$;}&Wnxs7 z5)^o%O}L{jv*{DZxkkD?dBwS|x~}&6MyMldYK7EW3#9PC*opLj%pK%enIV}p2+b&f z#l>9pSfj5bfbv}ldlyP$AO>T|Nwx{cMEB!x9G!}x^-?Ml3v8s!tEuQ|7Dn(G)I;IZc!XJIqp4JdIhp2wqJsp zmB*m~SuLR$ivZV0D9>AU2sE8f9&?i@`5H|Vm!!WIeeio`VlijX(SU?hJwig-4{Oq; zSTEwHPN-prud6=L9&pu)Iio-@&E>OGx~}bA_0rXB*TdI;bop(0 zL{hfoq!aD`xb%FpcM*pwTaXs?DQM2Z#imFv6cBNbUgEY$MgpuFG|n{Aq+F(HCwbVj zXpJZbOIMQZO|t&SvKJ)N_&L{qn{uO~XF&e{k8tywJg3` z`fH2`D5RY5qB(jaOZpE>$zGF+X_TxIWHT_!#x^f}=()1fjf_L5wDfn^-Y!|##<8s+j-M&{=fjK=6n zIVXzF-r^OSU+rTXA6hv3%bQzc;*%>hS+pvUpDCID0ns0FghQMQP~j2>Bz zm6rKI^mOH(6oxr5w!NoFo}0dM%WV-{$c%8!Ew_bO#a|(DLE~eTqTAjrRo&=^l83H= zg1l6=S570c&BzP7;*iCfV)|BAjavCA&AqyyMvrp-M?PaH`C`Tz1d!mG zga*I><`FRbYD5(O9DtxCOiTfi1R43r8k8hsh-6(hIYE}`Pf5FN-&%A z2gIHT^;2V^pisrzD50TljE#wX#uzAti;*TK^fwy4915Krr)T}G0_cw`qc0n2#xH1$Td9<4B?#wlY%gEK5a zXW+A;G$M_LE9UV>TWCq^Dt=nAwnZLBv_j&)-IDHODIvn%!TbbaiC<8Mjj}=} zF^vh8-(-6!WFq85?KKo6QflME<^x$!)yehWp=2t0oA#(ytX>Y&WS2k_kEP>4gQ5oX z;Q}iUsW~!LX~k3H>?1|-jZCdUxg1o>xr_8WX}D~=RehIYRm-oCB}>AD#9r9}B`D{Q z<;t4{)zI){0!YA`K&3CEXJYA`=3Yj+kuP zD?1rLGD~T&LAsR&`G*t$Gr3ZN22?UUR zGhsAm&I$qxU_*)_loCT_bVNBHvMtMpDvbQ_>WeNI`?zu%7rH9O4Ho0NW%+rq4kMpG z0#pVU5=>9ZcNs2861H!)nDrqsa#CK_>_1A-DgoFips;`nxAw}Yh_Z2`VenWpIwGbnUV$sw(QsvS#UrkoxI$$zA= zY!a8Kf-GriI4PtqlBEIa@Q0J^i6I=3_6G7(AT3~U)Dw*qN%btXhiZ_1Sy$Amo-`Xw zF;jC5?>p4W9kTBld)%SSoa4#4QFCFU?{#D}Exp09K@7tiGJq>5^4?}3rkuFldXqk9 zqCL6}mR5JPwYGP5pOftBXovEoPDmOAT0AA7DIEKRwWCwZdURTaEwt1Jua$Nh0-9Pi zL4fuSA%HnXI4rAPZFl}W2nJ=0a#^!oG$tT0Xq^g<9ZaQ)fFRcrMh2SStg=V`G$4Qo zf(-e4TaI}lf3LOJ1EWJtd5iLaL?JVF!ViKV29-dN33kWN1HsXplCaixt2Ku~6~sGb z_Qv4L@8O`FDb3_`jOXBdzZilY<0>%Tt{+Ma?d#)UOQ6~0>1bIUO+5SbK1Iegyd{Y|xJ z9aO;SMHG*t^!;%Yt&sRGTwjPo;TS7zgH`h@rigBVupB+!r9`t^ws4BQ_d(sl>}HWb zHHNAa5{=$6kab$?6Nrzyk>96>ml~SdWZr*yNdJU3XO|^hlkL5vaJ6?USg{=6K#DG? zkUcwShjCuO5&@dEI7b>IuKzZrOVQp{-&gj*&41!(n+1qR9h*&(Y+WV(1j4Ld(*y0o zj0DTT_<^#NB+YrEf5;N>+K5RjFZdkn10HPX<6-~`;s+A+M# zIoVv2crRRY1&KMC@qow2IICLQ+gm%JTDSwc@OL%wjVyRwuyD36Uss3AA6V$Bt*Yh| z+~vH}B9d>TFh#6bp>!c-kgf6cn^;=YN2bz@o|uz4Aaggy(a(q*W3aS)?0wAX$mVkE zJ#*2DeLRInbyFF|$c2-H1!14#@5uV$@6F{iIT5BH-30*-A_9n!b}QNveQN&AirJ=tD_mLlWoPKj;y3`w=O@$(^Qo5@B~o2WpM z1+Lz(s6yW-tT8#j@cGG!GdT7q5cYuR!6E<;XGBg6bo!c`JKCV;JAfPq@$2Mk+ZzMz zu(HH8xxI1W_Vw*epphNTzOIH4*OoIaaE-pwzaQ(L{3l#k#?IUd*cz+u-{tbtjHW#Q5 zt23moa}`uYHzIZj8oRlvuyoez8d>Fa7rRDI_Q=XR5Vv9@6%z%xlxi{=J1gPGs91!S zmQiWWpJA0bRE;o_75Nb(3KL2sS|OYfxnL z!Q2>M`VPzgln)8K;goc!*;`E)?#s@U*y&l0LFj1{&fwwteHh>w$!Q{g%4kCgXURp3aH5^Ldbr4D?dmEGP z&mwqOJ8krmaTQcqQ{jiuMo>pu0YY%$w4KopBQYvhM3J0-EC+Lj08?-r!K90PrW~8{ zQ#@p0&_71e;D<^fWc**I=*MbXwFadO_6IFj&cWCJz@^U50ZbJBH1um2jM5`N-)z}1kygvhna`zYu#h5dpe2idNrFq zAu(JJ35boU=W-OUuvVfOce*zumtMt2t+}is@!``f$kBn0m_7617p_~rfxhnxNLB`u zyfVkC@pLyB8AuCoL;`#RU0w?$*2EWkA5k_>S59_*9K}9N5~QR&i;*H@ugI1jw3481 z9(5sUMB*XYDqHZ$Jia4uP+AN_N{3N-7QfkHl%{bpSx1=^GozkM3%A>(%&K@-H^W$; z3X5sU<^U@ud-%c#o-^_kM_cRoo|Bq5gEEcQ0z=I3iYTBH1H2`4Q4nkOEIW5q{L)ixHfY^SN zi}TPSlRYXs9#N5I6CppybRM4(Q3nWs=>%!(hRPJ#m63-|)EM-~HkLP>?U0);7@4w` zo?Wr}jR70q^0G%!EMEr%V703;G@UO;|GP1%MXY^g^S+6-FS##*H9a)bU)k?7b|36) zU-j?}jOMB^CN;|%yMr!;PnrkL1##DyVFS>MT%!(QORGQXAGhKD0%NGo=k6!7ob|&t zM;Gm54`2xbRa_*DS?WvrU?)wJ87X{soJ+4W>QY3qfKBooXnDHwb~YPJ5^v)L46xf2 z+T0Pxp7`qS=kNUsC78?+3pnV-+z$$hOL+;Ux&VDahF%9@Bd2OyP7DcV*7jkz&E8ee1TQo#(?IydE_Cyr9s z;+r4*==3d1*uA)61`=Szw2^=8d*YsLWc+3PU#IAswCB~Y)uGBdrS8{i{%Cu40uUwa z0A~V6R1|E@r9zD1sdxJAPUn~?dydnY<99m!gW?Cp+wFGUKiL_5xAN}X2(w27{ILcV zY&p0gIPu*?VD$^U0M?hNu*gKyqKbS@N_c8iE@`J5x@r`4X#Pw}lu+(9Nq<{^J5#eV zRa>}&xn!NQ`vd+pv&NR4AY@UV03HFAgiJOHeU^S=NMjjh8j#`em%OF5fRkpaH>2{= z_i!NTCqx;I2=N2Wu9Gx6olYzNj-T4B9P4h08cljc>P~Ye{5cFxUGa}21OLR-JwAc} z05%`mCEdAhVMcG-BHtJ!7Jaczo1jk_9P2PA;CVh^i$%^c=q*MF`O~GYm0$D@_p* zVl-I6YY?$_BxMO>HCKO|V4bLPt$^LdgfhtsSF9-13b>y%1_Z(H^!qKe5d0vg@PXgY z^*;i_64=vwg7&#~3yu@v>5=3A0|m?>(b*|n@%gGft|U@XgiV7sEZx@BlKMH`d0LXC zr+Xz~NFptzz~?$C0sTO8k}0NZCb#xcnr8i!^a(Y?NqTJU-!v#5Oz?PTxMKmIqJcB9 z4uG{79E+Z0^V)1l5l+AIh~2K{*0_|*j7-o8O`oObMD)vvyUIB^ie3c^e8DI2L-;6% z<)ez~?OsjSExc{I({HnZqe^MBX%U3I-wXaKZlqzWiljHnw~03j;P8!_qY!{|aMk2q zZ?g1y;Od}Z^ZT7@Zb};wXugA9hOi0nfJ?w9bfI1jUZkF+IrT^ZSo%z`5@ce!U&-Vk zk8+YC2E_x^POkqpL_q}faKUs^vHQ9H5vgNj@4y{vqdedm> z7XFHmF)W7U>}bh|f*7(0Vn~m>dn%zpc4fFzWGaA?9hmtv?3e_(p>*>#g_p%yD;t)@jxl4g$nR2)k6k?a$wZjfW$Qkimvv^8&R!OI;fL65a!ZU6bN|&dr(;kWg}~;r zW)A#9Axi>yi~ckS6c3s+93fLrd?u)Fj2shs#6Zf`)dGKTW(-K1NcMCaTP>e`;tLnw z_AcvvZ|@tjKfS~lF4EYavDvnfr@Xq;!{l? z*Zf}%o_Tx+XZH$ZHwbGtSry`|C>2F`rCl&!Q|39C+KO?!xu7 zMGj4682ymllk4UFEjVOm3zX|0x_N9mTaono)?Kqsqv@UzGm>BZ?tpuyCEL~Q9N8&9 zge<3MdqynBP@*?+GDmM*pmAAy>w7FNEnaolQINyXcyPJ?t6$97p~}nw%vwCOTnHniD^y4UpKPH_!AQ z7@x>ae!pqwsfC*?v>NxGvo$I0ax?k_jt->nrJV=J$8x(x zw0QOO&q0S;mCkCD{qA<=j=2u8jCYSx#YJK>A%d z3j&SXuMD_`x_*)goqzwme@eJ)FH7)Esr~bfD~!=|q;08s>VwO_xw(<{HDvtnTmJ2} zlMUA!!i5^+b7iIQ@%yi?e!t>nwybMM^qn8fXMe#(SGX#9gzwVt=ATo1mSr-VIypa9 zT3B}X4-!eGGb8R$SYmF{Yhn2#4gxLYh%cZ2bluiJk25^I#M%lrxLTb%b#ejQi#gM= zNCgUxE|i;~8oe>+I`thnP1S~J;S-MgY})Lp``Af4CS2V^%O*{t3DXgCM>i~O%6&xY z|J{n-qCKSzQ?FM?D0jmgz`vyifW+l+Tupr?=Tg?eCWaegF6&a zY0A*5q9bT7!;Cx?CcJ^xiK-`07Ig>(X7A+$6(5N)~|YdJ=$g&}g`h|MaF#F1RAx(@dLt5K91-LGDu9i<#lQsKW}c$j@n zWdLMlLj7zQf)Y!3`>M>SgFI~(WyXYF( za-NvoCH~5VMin&15DZbUlH*qkvi5>vGgD2CLn6`MCwYI^G!1|`>lX^~VgDI$ zQT=ILG&5o6bc>520kKuOMhTb)k$cI~cK_nQI96M%=<04o-L0RkeRJ4RKk~x=76m{( zBSO`at7f=*V#uJJn%RS^XIRV-AuE)v*+d))7zyZf_e=Ht#jyhbbJ~B4GQob$7}LRN zB%{bM^D101&`Xj`S(6zLirGDkG<5t61vL7kaPm7Weg2u@WE*6UEo(3PCYD)-UO<0Z ZW?axtgfh;mcc2=v=uB?@v%WX5{2!mk0ZIS> diff --git a/deprecated/settings/A01_fma_2050_2070.txt b/deprecated/settings/A01_fma_2050_2070.txt deleted file mode 100644 index 562a18c..0000000 --- a/deprecated/settings/A01_fma_2050_2070.txt +++ /dev/null @@ -1,37 +0,0 @@ -# nuclide vector -nv_name : A01 -years : [2050, 2071] -use_decay_correction : true -use_fmab : fma - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Fe55 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Ni63 >= 80 - - Am241 <= 3 - - Pu241 == 0 - - Sr90 == 0 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A01_fma_2050_2070_Co60.txt b/deprecated/settings/A01_fma_2050_2070_Co60.txt deleted file mode 100644 index efa93ad..0000000 --- a/deprecated/settings/A01_fma_2050_2070_Co60.txt +++ /dev/null @@ -1,37 +0,0 @@ -# nuclide vector -nv_name : A01 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Fe55 - - Ni63 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Co60 >= 0.2 - - Am241 <= 3 - - Pu241 == 0 - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A01_fmais_2016_2026.txt b/deprecated/settings/A01_fmais_2016_2026.txt deleted file mode 100644 index 6c67d1a..0000000 --- a/deprecated/settings/A01_fmais_2016_2026.txt +++ /dev/null @@ -1,44 +0,0 @@ -# nuclide vector -nv_name : A01 -years : [2016, 2026] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] # (is weglassen) -# optimization target (measure / clearance_path [look at "additional settings"]) -ot : meausure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : -# - Co60 >= 5 -# - Ni63 <= 70 -# - Sr90 <= 5 - - Pu241 = 0 -# - Am241 <= 3.85 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 3a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 3a, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 1.5 - -# additional weight for Co60 towards Cs137 (optim. target measure) -co60_weight : 1 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A01_fmais_2050_2070.txt b/deprecated/settings/A01_fmais_2050_2070.txt deleted file mode 100644 index efa93ad..0000000 --- a/deprecated/settings/A01_fmais_2050_2070.txt +++ /dev/null @@ -1,37 +0,0 @@ -# nuclide vector -nv_name : A01 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Fe55 - - Ni63 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Co60 >= 0.2 - - Am241 <= 3 - - Pu241 == 0 - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A01_is_2016_2026.txt b/deprecated/settings/A01_is_2016_2026.txt deleted file mode 100644 index b9ba8ac..0000000 --- a/deprecated/settings/A01_is_2016_2026.txt +++ /dev/null @@ -1,39 +0,0 @@ -# nuclide vector -nv_name : A01 -years : [2016, 2026] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [is] -ot: measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : -# - Ni63 <= 76 - - Sr90 <= 2 - - Pu241 = 0 - - Am241 <= 0 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [3a] - -use_upper_bound : false -upper_bound : 1.5 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A02_fma_2050_2070.txt b/deprecated/settings/A02_fma_2050_2070.txt deleted file mode 100644 index 86a4bfd..0000000 --- a/deprecated/settings/A02_fma_2050_2070.txt +++ /dev/null @@ -1,41 +0,0 @@ -# nuclide vector -nv_name : A02 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Fe55 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Ni63 >= 40 - - Am241 == 0 - - Pu241 == 0 - - Sr90 == 0 - - Fe55 == 0 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A04_fma_2050_2070.txt b/deprecated/settings/A04_fma_2050_2070.txt deleted file mode 100644 index 544c6d9..0000000 --- a/deprecated/settings/A04_fma_2050_2070.txt +++ /dev/null @@ -1,42 +0,0 @@ -# nuclide vector -nv_name : A04 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Fe55 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - Ni59 - - -# constraints (in percent) -constraints : - - Am241 == 0 - - Pu241 == 0 - - Cs137 == 0 - - Sr90 == 0 - - Fe55 == 0 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A04_fmais_2016_2026.txt b/deprecated/settings/A04_fmais_2016_2026.txt deleted file mode 100644 index a85d199..0000000 --- a/deprecated/settings/A04_fmais_2016_2026.txt +++ /dev/null @@ -1,41 +0,0 @@ -# nuclide vector -nv_name : A04 -years : [2016, 2026] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Fe55 - - Ni59 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : -# - Ni63 <= 76 - - Sr90 = 0 - - Pu241 = 0 - - Am241 = 0 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 1.5 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A05_fma_2050_2070.txt b/deprecated/settings/A05_fma_2050_2070.txt deleted file mode 100644 index bef12f5..0000000 --- a/deprecated/settings/A05_fma_2050_2070.txt +++ /dev/null @@ -1,41 +0,0 @@ -# nuclide vector -nv_name : A05 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Fe55 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Am241 == 0 - - Pu241 == 0 - - Cs137 == 0 - - Sr90 == 0 - - Fe55 == 0 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A05_fmais_2016_2026.txt b/deprecated/settings/A05_fmais_2016_2026.txt deleted file mode 100644 index 1b76906..0000000 --- a/deprecated/settings/A05_fmais_2016_2026.txt +++ /dev/null @@ -1,40 +0,0 @@ -# nuclide vector -nv_name : A05 -years : [2016, 2026] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Fe55 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : -# - Ni63 <= 76 - - Sr90 = 0 - - Pu241 = 0 - - Am241 = 0 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 1.5 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A06_fma_2050_2070.txt b/deprecated/settings/A06_fma_2050_2070.txt deleted file mode 100644 index 3fffbbd..0000000 --- a/deprecated/settings/A06_fma_2050_2070.txt +++ /dev/null @@ -1,41 +0,0 @@ -# nuclide vector -nv_name : A06 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Nb94 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Ni63 >= 10 - - Pu241 == 0 - - Sr90 == 0 - - Cs137 >= 80 - - Co60 == 0 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A06_fmabis_2016_2026.txt b/deprecated/settings/A06_fmabis_2016_2026.txt deleted file mode 100644 index 4d2a9f0..0000000 --- a/deprecated/settings/A06_fmabis_2016_2026.txt +++ /dev/null @@ -1,38 +0,0 @@ -# nuclide vector -nv_name : A06 -years : [2016, 2026] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, fmb, is] - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : -# - Ni63 <= 80 -# - Sr90 <= 3.5 - - Pu241 = 0 - - Am241 <= 2 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : true -upper_bound : 1.5 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A07_fmabis_2016_2026.txt b/deprecated/settings/A07_fmabis_2016_2026.txt deleted file mode 100644 index e546a95..0000000 --- a/deprecated/settings/A07_fmabis_2016_2026.txt +++ /dev/null @@ -1,39 +0,0 @@ -# nuclide vector -nv_name : A07 -years : [2016, 2026] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, fmb, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Ni63 = 60 - - Sr90 <= 3.68 - - Pu241 = 0 - - Am241 <= 4.08 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 1.5 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A08_fma_2050_2070.txt b/deprecated/settings/A08_fma_2050_2070.txt deleted file mode 100644 index 25274f5..0000000 --- a/deprecated/settings/A08_fma_2050_2070.txt +++ /dev/null @@ -1,41 +0,0 @@ -# nuclide vector -nv_name : A08 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Fe55 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Co60 >= 0.9 - - Am241 <= 3 - - Pu241 == 0 - - Sr90 == 0 - - Fe55 == 0 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A08_fmabis_2016_2026.txt b/deprecated/settings/A08_fmabis_2016_2026.txt deleted file mode 100644 index fbd1b5f..0000000 --- a/deprecated/settings/A08_fmabis_2016_2026.txt +++ /dev/null @@ -1,42 +0,0 @@ -# nuclide vector -nv_name : A08 -years : [2016, 2026] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, fmb, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu239Pu240 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Ni63 <= 76 - - Ni63 >= 70 - - Sr90 <= 2 - - Pu241 = 0 - - Pu239Pu240 = 1 - - Am241 <= 5 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 1.5 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/A10_fma_fmb_is.jld b/deprecated/settings/A10_fma_fmb_is.jld deleted file mode 100644 index ec2d354cbd1b8a5816a587136ad8ca07d26f7517..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 17578 zcmeHOO>A4o5uQidGGp0|Tq~~Pw(d*fgM%8XNd4F@oa9NO6xy&QMN$#g7n-r39Txg= zDW!i!s7O+<$bx8DAztd#J+>HD#kOHN25uowqrn%bM^sUefrEe(%vClCmzP zcWC`@YBM*KK0P@yLd=Qw5Nk2r+iO!95R&+7g+O6sa6$%L)KNp8?y8&tjM9~ASgy@i zk%wFcAZ#%9SYDgSZ=ix`I>mKb`K3gDH;C`og*`66&|^!g*MI}$6>C_VYiwaBi@4@!Z(>m=vcwoJ_P7F>D7w)V0^4i{dy%0FS zwmPnF9(*9K4?RCVnJ-P9yEGE0aPueY#+7;Zm?nJl+o*5t3P>}TmrCzx#Pg2%u2p`T ztnVMa{Uc-fbAw~0q4A5iRk{UN#({ZpeuiGjC;{h=Aw5fu1{}N4*|Dg&O#H!5aMgNC-;;ie3i z<2}BY@~;Zb>X@m_R%%><|5YDy*&+WKy}1U|*G_$3@<4tbR<6IuAD`I7w+GDViPC)0 z$;jRDC&ob`l1YboAY!P7$PLfWE!3*z%3LivFZO6*v-`Q2I#MaW)9qGtUbNL_=(H(L zb3f!JzX`ViIi=`)gUJYOzHEIT+A$@ASawwsrJ=yo@LkB?4}E?1O(c6j`P z!AOM@CKIn82XWLhRXtG5`-i1DM{<1sqwS2Ep#fPs+2 z2?7ZM2?7ZM2?7ZM2?7ZM2?7ZM2?E=U0Q`4bX^)XR66`T@f0jEU^0?O$bp}l4(AxHx z(W$8s`i+`kyoWvdOvd!;+tUv+stFs1?Z96!2i{^=ar3ypO4~NHHvW!Xd~c~5UR(GS z78*OcHhss#?=8~TW^cZ1jDHw9$J>p+*r{CkhdqnvcwoEnV-vTkJ<^V0^S|4HzpH=5 z?&r!s?1NE{6Z|~}V=MK)i?^7$T=|E+mB|7BacFJ*W5=-hU-+#f{H-IyV}FqZ*u@dc zdqgP_yR7Jz$S;C-i;-XCt{QcVx)-fH$sceie&5C`Cv9Bpwz2%i^-$#JIq3R%!kGtp zdM-zmZet4mx)pIQa0twA^wUPZ$*}%E$o{s{+)GzxDp$jW-jyFjOq>$`smSSlrJ~;3 z>Id}gba3fi<=7pOvwvoKY{2b%JO@8&BhJgFA3OaA`%IVa$#(aSdhO`n_Un;exjmpPz<+rS{Q|!?;xy|Y zVO_uc-!UzvX?c}=i{I9jck%DKdGQ0gdC|dcUbL5+7yq`K7r(Zf7k{>!7eBUp&WHcH zQ4V(2dK;ZAOqfRvDR-O0|6;KHzyuf+%#ej5LwAC6igu`tNj{0!zqD2RJo|41;JkV4 z=qp3hg*-#ad{XPx6Yr=oqrLt%;;Db_dwFzCs7xM?Rb(ne9$G_Q~hJ zrO+f#-T3SeB$ap4eEt`&(OV|@?yqw1(rYG}`^N|G(O*sS&yW1`WBR>GzJK}17xbP< z{{1iW`gDV{N%-F*0L?X_!W2Il$?BGXc;lL@XueOgOuCxGXR4c*7b0$6UXr+Zd5Pj` z8oWT+>6!-k25aCew{!`JH;!+?e4nOZ6<)`g>f-lAEdLniT|6H*wKU#5ciKq_H}$SH z@RU=IgeZQ{P2E@iF6z>4|DCgjM7gJJEWdF%JHU8LNYh$3a@l*elQcYE4Z8=c)$-ym zO>(MM<$KA=?5~+;LaN#FFj~kD5gsQ>?U!EfJHXfP`t=fK35S-0iNc}v!d&6d`e3?n sX#Fr_IJ5znG#uI~93vgtX&fmX+8InnM9cPIVjNo5oun;Cv2`o_FR?}pi~s-t diff --git a/deprecated/settings/A10_fma_is.jld b/deprecated/settings/A10_fma_is.jld deleted file mode 100644 index 7dd7d6eb183847ae032449a39a8f6097e35ff009..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 17826 zcmeHOU2I%O6+YLSxZC`I)3_lGP;N^rxe$zZ{Sy}jdN=;*CQ7}=8^j7BZ8phGy2w9a zy=mhDugFCp^$Fz#a3dk|g48}#Jc4*3@PK&eLsY54DlZlisFe^BLJ-cGIp5y#^*a91 zx_I3?l6Pj#oI7*on=^lBj?dkgu2%djm3qa$TAdF4p8V+e;4>%vm%`e7b#B)0>&^6L zC<%KNfmeCF4<9&j!1OPjrhU|9yV_x+`x(_|yf{B&T}dke=Z@q&+b$aM|B-XO^K7YW zwLIp~!zAd{>e8*}wtC)Z%m+&2YKSASX&m~$eALPk#6-{J{Mn&MQ!SjX)Y*8C z@1^`fp;;Z%)tPFYEASumA(tKTpVOObKm!M9;68Wc<*<6~MgF*F8{Zx>y(dcXMJFwH z$8VVj3eikD${i6yHB@e7Zg#$2t5j#}(Rr~?3!B}~#njQ!;di@YMdw9ZZJLHnaf;=T zb7e`-MPg=j^N=B`>;2~>z4m;$6tV2$RHV;;I%UPYWPwnb zfR{b16HOE*#^g(wZ$TfK8|o9fnxzcpk_SKdaHk)c&-9DH$fLf~UzV?kZ)Y~3eDX$i zK;E-(UXJt2S|2Kd2rtY9rDTRJnRLL`0Z_v z87~&cXi-ft-oM!Z;BnXfG4so>L_K^^YNzoRyNcZDfj{o4Y$*<`TApo^E{!u@+m)dFk#hm5h4|{7Q zZGyk-7_D4?-2GSV((d{b&Cb2C{zrPWy%hWghGh^qc<|5T_c{q!uMvwssFa9ZT-NsJ zT?&4q0aN8&WSH)%QN5%OZ1tpE zyUMXQB4-~>_t}tfUqG9bXIIo$KoCgLvUz)I#k=%ESgFaIG~TGzLl|@5GQS0e-!3=a zgf`-@S8CTnes}iQV^n&x_wHyOG=F!N{RJxWe01Jpnmy-rX<>Yxi_S?vym>!y`w}Mn z%eqMX6^jMe7oW#OubFoC+7Ix>{M;Dd<7S+ijj>=8t*dr8)9R&=Vy%%oB8mFBpWbqX#6zH)7LNU8n&kDmn;!rB zKfh0*NuIj?!B0pk@20uYS6-*zo8;Ty&Av^qn`HL4@4ZWJnPlqX7gp#4ll;Y_fBYN$ z$Rz)K@z{UqU6cG_VWr54Bz&j{VCC5O1nlm2%~lAju;LNqt`Oom5g6YMqNO3*HTOmW zkBhY{#?pt1!*&}3eoHzT<0~&bUl6BwpBC25ue^7RXenAUiwIU;@z8KrUh(8`^D@WX zyzG;1UOYwIym+#>dGTOz^D_6{yd19Gn+`lx){f)uTKO?vlk1F^^hpBZt&dm9e4pYq z*v0D!rn-4QmKRSMw_H4JTzuhS(=PZ1>)BMQ1q(8_W&*5{%H`Au$xEx}(*dX9!N2Qu}-N-~2UScN^C^ zm;)SI7N!A*)(W P99q^LxRxW^9u@u%o(v}3 diff --git a/deprecated/settings/A10_fmb.jld b/deprecated/settings/A10_fmb.jld deleted file mode 100644 index 9b5c3dbff29a127255cad465ba4e51f9ad9881cb..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 17810 zcmeHOO>A6667DyXn88VQos9_){$7BCBZBdae_~J&Z(@5gjuMa8lNAG($s~DB2KgsD zozzq=-{4tc+GGa^!-LIIZ@wAqP$zd_h=n@gjl91%wbkRo(T?Yd??U*z!Qe zyp}xORb8)tzOMeOE+4x%Q7*Y>OVyG)UY_vXj_hEj_rO8-MZYpro}O~MI+LAA6@{&e zz-u(#yIS|P>i#7XYMW{^U5%OOX9;f&EvF5o)G0|g63_o4y8xA!v*Oz^y!-D8Neu>sraSpbOki@(gS0i zu|xV=Pk%j8MBOMV)99~?^mm>3{$9kx`ipgJPS!Qx0DXmCfxpo>Kav}CNP|(I8#g7P zo~+R4L+#jTeOvWAN44m6AR)j3QQ#Ptb)t=cHduQaitR+POw5UC(S+=O@!E(O#Qr2S z3k{6S&@wk~GH&zVSZ!y=j*ZwfyjA*-ZeahvdZ*!d$dI@ZINPe-tT+QVwWB_6Eiw*H zo3rECUycu_izkLha$}bIgniv^`*JJ`Rjsb0o&}jzPD>l zThGH6r_MZ2AIpt( z+#wyX@>_>S28Yul#Ur^BS46uRSHgj0ael_Sk`M;Y9npEVSv2CeY3FL^*+Sd$_UJt)FemUQFp%d-(>{RuV}u6fQ!gw2&^_= z=0xuxyxH>w`aPdAHDpnd#I^a+=Cl;6vlsjscegFV`vvcyxc8vEInjR)4OUC`XInnK z-gOALEp{7dybwZk4R`pSvX>4sT@+81CjDYarXG2(!xk!~|IAP%RK=etRmpgd?>YZw zphQD>yHjViT%gXUC}>e6B3W zxroh-HjOp}WqtDur|t7)rYZ07|2bs(G-iO14u{cF2WFDp++fhihkOfvOac6i-`mSH&dcCKp4U1K zHGa8I&sf~|(B8vO8#(iE63FK(PwMvLCKHy&K^*NJy_o9Z_cggD)$l<1e=yb5`j?(G z@_!UQa2lUHtvLdBt^JdJX^Jzjs6#%T)XgM)H398RnPL>SCGfk2kI4gmkMLzXsI|XW z_vzYApCGU z9}LN(oezchsMihgQSbf`AN4*g{BXUGgyd20qai-Z7q+?#1p_0BBLpG@A_O7?A_O7? zA_O7?A_O7?A_N+Y0N(F5(;mZjB-ms4e$IcOajy-!)!g=&Og=xPE{O@o`GE`^4t4GC z?|!!s^zde>M&NJb&2|-=#{D&DQ*+}Fd+n8jrbo++VZ^fR<~z>$Q+dByEl-`Bx&D*@ z&}jVGPG#c{dzMsBQFG&O;k&(9@yBPrfrZTUutof+$loPCK6&W{FX*^VH5z}m`^D%F z>ksUM#PaBmLUZG9`mpieM&NI+|7_;6@rS*YUaCCP>Ii?{F&ef1vR&H7KbV~c_elSZ z-#|YP0tE;DdGub#0qZql_6Ox0wu|%H9=uDzZ`30$zl-#%YhqL{bZC}ZIAG$!V?xWG zRp=D@2@~^g_|!mp#Hlv?=Mi1 zqrrKPc*g&;O)|stoOO-^;#>CJBxX-5_~6sMQ3qTkYibB} zl>A$LG^86x?Ms8WOEA8bmSWU!#|P(+oXidq%p}Ki=4{7xxjOAssO4Yj|Bq+#B&Ec?w~hP;FDaKulXFFOI=uQKe(8TNzINo~@r>HO@cO@Zt6BP>U46gjpNG|-b@Io~ zVoC9feY=|7`^ALf*Xnll;Md>&L-{&+=)#S+6&K#FrU(D_j`~O^KY1nfiF!vTQ~&+^ zQ}w=1#!o%Iq;BZsyLWy3m3mVrKRdPeC-tdLzL8tXQz8n#Dgsz3);{st`&+#g!6+tAWF>ZZljyk11G z(z2%pFDjsUPTMqle%Lgh4s4qDNteh{y9BX)Jq8TZ!1280iJkEgIt z`(m1OSkHD6-W=lOb7y&&S~p%^aio!IV7lUWrYn`w?8`ctuU5#;docMb$&7L_n;tUR z!6OPzm|Xg`>!+Wi>uv4&hU>q@OTiRi@w#Cauy{Q%5m>z51u+*`ygrx?EZ(67F(X*K her$*q?@4Tq0WaBw0kU{W43@=9*#o!f$TmlTzW|BH9-;sM diff --git a/deprecated/settings/B01_fma_2050_2070.txt b/deprecated/settings/B01_fma_2050_2070.txt deleted file mode 100644 index 97bd186..0000000 --- a/deprecated/settings/B01_fma_2050_2070.txt +++ /dev/null @@ -1,39 +0,0 @@ -# nuclide vector -nv_name : B01 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Co60 >= 0.1 - - Am241 <= 1 - - Pu241 == 0 - - Sr90 <= 0.23 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/B01_fma_2050_2070_Co60.txt b/deprecated/settings/B01_fma_2050_2070_Co60.txt deleted file mode 100644 index 7974ad3..0000000 --- a/deprecated/settings/B01_fma_2050_2070_Co60.txt +++ /dev/null @@ -1,36 +0,0 @@ -# nuclide vector -nv_name : B01 -years : [2050, 2071] -use_decay_correction : true -use_fmab : fma - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Am241 <= 1 - - Pu241 == 0 - - Sr90 <= 0.23 - - Co60 >= 0.1 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/C01_fma_2050_2070.txt b/deprecated/settings/C01_fma_2050_2070.txt deleted file mode 100644 index 4e8067a..0000000 --- a/deprecated/settings/C01_fma_2050_2070.txt +++ /dev/null @@ -1,40 +0,0 @@ -# nuclide vector -nv_name : C01 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : -# - Co60 == 0.1 - - Am241 <= 0.5 - - Pu241 == 0 - - Ni63 >= 85 - - Sr90 <= 0.2 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/D01_fma_2050.txt b/deprecated/settings/D01_fma_2050.txt deleted file mode 100644 index fade4a0..0000000 --- a/deprecated/settings/D01_fma_2050.txt +++ /dev/null @@ -1,39 +0,0 @@ -# nuclide vector -nv_name : D01 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Pu241 = 0 - - Am241 <= 5 - - Sr90 = 0 - - Co60 >= 0.5 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/D01_fma_2050_2070.txt b/deprecated/settings/D01_fma_2050_2070.txt deleted file mode 100644 index fade4a0..0000000 --- a/deprecated/settings/D01_fma_2050_2070.txt +++ /dev/null @@ -1,39 +0,0 @@ -# nuclide vector -nv_name : D01 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Pu241 = 0 - - Am241 <= 5 - - Sr90 = 0 - - Co60 >= 0.5 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/D01_fma_2070.txt b/deprecated/settings/D01_fma_2070.txt deleted file mode 100644 index 03ccec1..0000000 --- a/deprecated/settings/D01_fma_2070.txt +++ /dev/null @@ -1,36 +0,0 @@ -# nuclide vector -nv_name : D01 -years : [2070, 2071] -use_decay_correction : true -use_fmab : fma - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Pu241 == 0 - - Am241 <= 3.5 - - Sr90 == 0 - - Co60 >= 0.1 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/KWO_fma_2016_2018.txt b/deprecated/settings/KWO_fma_2016_2018.txt deleted file mode 100644 index cd01e1b..0000000 --- a/deprecated/settings/KWO_fma_2016_2018.txt +++ /dev/null @@ -1,39 +0,0 @@ -# nuclide vector -nv_name : KWO -years : [2016, 2019] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma] - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Cs137 <= 5 - - Ni63 <= 75 - - Sr90 <= 1 - - Pu241 = 0 - - Am241 = 0 - - -# additional settings -clearance_paths : - - fma : [6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 1.5 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/NV2_fma_2050.txt b/deprecated/settings/NV2_fma_2050.txt deleted file mode 100644 index b424485..0000000 --- a/deprecated/settings/NV2_fma_2050.txt +++ /dev/null @@ -1,40 +0,0 @@ -# nuclide vector -nv_name : NV2 -years : [2050, 2051] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ag108m - - Fe55 - - Ni59 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Ni63 >= 50 - - Sr90 <= 1 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/NV2_fma_2070.txt b/deprecated/settings/NV2_fma_2070.txt deleted file mode 100644 index b694d16..0000000 --- a/deprecated/settings/NV2_fma_2070.txt +++ /dev/null @@ -1,40 +0,0 @@ -# nuclide vector -nv_name : NV2 -years : [2070, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ag108m - - Fe55 - - Ni59 - - Ni63 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Ni63 >= 60 - - Sr90 <= 0.56 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/NV3_fma_2050_2070.txt b/deprecated/settings/NV3_fma_2050_2070.txt deleted file mode 100644 index 39b7e25..0000000 --- a/deprecated/settings/NV3_fma_2050_2070.txt +++ /dev/null @@ -1,41 +0,0 @@ -# nuclide vector -nv_name : NV3 -years : [2050, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Fe55 - - Ni63 - - Ni59 - - Sr90 - - Pu241 - - Am241 - - -# constraints (in percent) -constraints : - - Ni59 >= 40 - - Am241 <= 1 - - Pu241 == 0 - - Sr90 == 0.2 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/NV4_fma_2050.txt b/deprecated/settings/NV4_fma_2050.txt deleted file mode 100644 index 67fa756..0000000 --- a/deprecated/settings/NV4_fma_2050.txt +++ /dev/null @@ -1,44 +0,0 @@ -# nuclide vector -nv_name : NV4 -years : [2050, 2051] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni59 - - Ni63 - - Sr90 - - Pu241 - - Am241 - -# constraints (in percent) -constraints : - - Ni63 >= 75 - - Ni63 <= 80 - - Ni59 >= 9 - - Ni59 <= 15 -# - Am241 == 0 - - Pu241 >= 1.5 - - Cs137 >= 5 - - Sr90 <= 2.5 - - Co60 == 0.2 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/NV4_fma_2070.txt b/deprecated/settings/NV4_fma_2070.txt deleted file mode 100644 index 4383b2a..0000000 --- a/deprecated/settings/NV4_fma_2070.txt +++ /dev/null @@ -1,42 +0,0 @@ -# nuclide vector -nv_name : NV4 -years : [2070, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni59 - - Ni63 - - Sr90 - - Pu241 - - Am241 - -# constraints (in percent) -constraints : - - Ni63 >= 78 - - Ni63 <= 80 - - Ni59 >= 11 - - Ni59 <= 15 - - Pu241 >= 0.6 - - Cs137 >= 4 - - Sr90 <= 2 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/NVA_fma_2050.txt b/deprecated/settings/NVA_fma_2050.txt deleted file mode 100644 index 1d3a88d..0000000 --- a/deprecated/settings/NVA_fma_2050.txt +++ /dev/null @@ -1,41 +0,0 @@ -# nuclide vector -nv_name : NVA -years : [2050, 2051] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 -# - Ni59 - - Ni63 - - Sr90 - - Pu241 - - Am241 - -# constraints (in percent) -constraints : - - Co60 >= 0.1 - - Ni63 >= 60 - - Ni63 <= 70 - - Am241 <= 14.7 - - Pu241 <= 10.45 - - Sr90 <= 2 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/NVA_fma_2070.txt b/deprecated/settings/NVA_fma_2070.txt deleted file mode 100644 index 8e8e37a..0000000 --- a/deprecated/settings/NVA_fma_2070.txt +++ /dev/null @@ -1,40 +0,0 @@ -# nuclide vector -nv_name : NVA -years : [2070, 2071] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] -ot : measure - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -nuclides : - - Co60 - - Cs137 - - Ni63 - - Sr90 - - Pu241 - - Am241 - -# constraints (in percent) -constraints : - - Co60 >= 0.1 - - Ni63 >= 60 - - Am241 <= 17 - - Pu241 <= 5 - - Sr90 <= 2 - - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 3 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/settings.yaml b/deprecated/settings/settings.yaml deleted file mode 100644 index 4403ccf..0000000 --- a/deprecated/settings/settings.yaml +++ /dev/null @@ -1,44 +0,0 @@ -# nuclide vector -nv_name : A10 -years : [2016, 2026] -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, fmb, is] -ot : mean - -# nuclides to use -# Co60, Cs137, Am241 and Pu241 must be in this list -# additional number behind the nuclide is a weight for optimization target "mean" -# blank means weight = 1 -nuclides : - - Co60 - - Cs137 100 - # - Ni63 - # - Sr90 - # - Pu241 10 - # - Am241 10 - - -# constraints (in percent) -constraints : - # - Ni63 = 70 - # - Sr90 <= 5 - # - Pu241 <= 1 - # - Am241 <= 5 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -use_upper_bound : false -upper_bound : 1.5 - -# additional weight for Co60 towards Cs137 (optim. target "measure") -co60_weight : 1 - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/test_A07_aufK2.yaml b/deprecated/settings/test_A07_aufK2.yaml deleted file mode 100644 index 65c5a44..0000000 --- a/deprecated/settings/test_A07_aufK2.yaml +++ /dev/null @@ -1,27 +0,0 @@ -# NUCLIDE VECTOR TEST - -# nuclide vector -nv_name : A10 -year : 2017 -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, fmb, is] - -# nuclide vector -nuclide_vector : - - Co60 = 8.94 - - Cs137 = 24.7 - - Ni63 = 60 - - Sr90 = 2.33 - - Am241 = 4.03 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/test_FILTER.txt b/deprecated/settings/test_FILTER.txt deleted file mode 100644 index 858b541..0000000 --- a/deprecated/settings/test_FILTER.txt +++ /dev/null @@ -1,27 +0,0 @@ -# NUCLIDE VECTOR TEST - -# nuclide vector -nv_name : FILTER_A01 -year : 2018 -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma] - -# nuclide vector -nuclide_vector : - - Co60 = 9.31 - - Cs137 = 14.3 - - Ni63 = 70 - - Sr90 = 3.59 - - Am241 = 2.8 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/settings/test_KWO.txt b/deprecated/settings/test_KWO.txt deleted file mode 100644 index 0047fab..0000000 --- a/deprecated/settings/test_KWO.txt +++ /dev/null @@ -1,27 +0,0 @@ -# NUCLIDE VECTOR TEST - -# nuclide vector -nv_name : KWO -year : 2019 -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma] - -# nuclide vector -nuclide_vector : - - Co60 = 5.31 - - Cs137 = 18.39 - - Ni63 = 70 - - Sr90 = 3.35 - - Am241 = 2.95 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" diff --git a/deprecated/test/A01_2016.txt b/deprecated/test/A01_2016.txt deleted file mode 100644 index 0ebe598..0000000 --- a/deprecated/test/A01_2016.txt +++ /dev/null @@ -1,27 +0,0 @@ -# NUCLIDE VECTOR TEST - -# nuclide vector -nv_name : A01 -year : 2016 -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, is] - -# nuclide vector -nuclide_vector : - - Co60 = 11.08 - - Cs137 = 13.55 - - Ni63 = 69.79 - - Sr90 = 3.08 - - Am241 = 2.5 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c, 3a] - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" \ No newline at end of file diff --git a/deprecated/test/A08_2016.txt b/deprecated/test/A08_2016.txt deleted file mode 100644 index c06883c..0000000 --- a/deprecated/test/A08_2016.txt +++ /dev/null @@ -1,28 +0,0 @@ -# NUCLIDE VECTOR TEST - -# nuclide vector -nv_name : A08 -year : 2016 -use_decay_correction : true -# fma, fmb and/or is -use_co60eq : [fma, fmb, is] - -# nuclide vector -nuclide_vector : - - Co60 = 7.14 - - Cs137 = 17.53 - - Ni63 = 68.29 - - Sr90 = 1.04 - - Pu239Pu240 = 1 - - Am241 = 5 - - -# additional settings -clearance_paths : - - fma : [OF, 1a, 2a, 4a, 1b, 2b, 3b, 4b, 5b, 6b_2c] - fmb : [OF, 1a, 4a, 5b, 6b_2c] - is : [OF, 4a, 5b, 6b_2c] - -# general -db_name : nvdb-v2.sqlite -ref_date : "1 Jan" \ No newline at end of file