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 2d39fac..0000000 Binary files a/deprecated/nvdb-v2.sqlite and /dev/null differ 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 ec2d354..0000000 Binary files a/deprecated/settings/A10_fma_fmb_is.jld and /dev/null differ diff --git a/deprecated/settings/A10_fma_is.jld b/deprecated/settings/A10_fma_is.jld deleted file mode 100644 index 7dd7d6e..0000000 Binary files a/deprecated/settings/A10_fma_is.jld and /dev/null differ diff --git a/deprecated/settings/A10_fmb.jld b/deprecated/settings/A10_fmb.jld deleted file mode 100644 index 9b5c3db..0000000 Binary files a/deprecated/settings/A10_fmb.jld and /dev/null differ 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