Skip to content

Commit 316595a

Browse files
committed
Update docstrings
1 parent 7ff7aac commit 316595a

35 files changed

+1556
-285
lines changed

Diff for: docs/src/index.md

+14
Original file line numberDiff line numberDiff line change
@@ -1 +1,15 @@
11
# LegendSpecFits.jl
2+
3+
This package provides functionality to fit probability distribution functions to histograms.
4+
5+
This package is part of the [LegendJuliaRegistry](https://github.com/legend-exp/LegendJuliaRegistry), meaning that you can download the package as follows:
6+
```julia
7+
import Pkg
8+
9+
# add the LegendJuliaRegistry
10+
Pkg.Registry.add(Pkg.RegistrySpec(url = "https://github.com/legend-exp/LegendJuliaRegistry"))
11+
12+
# add LegendSpecFits
13+
Pkg.add("LegendSpecFits")
14+
```
15+

Diff for: src/aoe_ctc.jl

+23-4
Original file line numberDiff line numberDiff line change
@@ -5,18 +5,37 @@
55
"""
66
## TO DO: Still needs to be updated once finalized
77
8-
ctc_aoe(aoe_all::Array{T}, ecal_all::Array{T}, qdrift_e_all::Array{T}, compton_bands::Array{T}, peak::T, window::T) where T<:Real
8+
ctc_aoe(aoe_all::Vector{<:Real}, ecal_all::Vector{<:Unitful.RealOrRealQuantity}, qdrift_e_all::Vector{<:Real}, compton_bands::Vector{<:Unitful.RealOrRealQuantity}, peak::Real = 0.0, window::Tuple{<:Real, <:Real} = (50.0, 8.0), hist_start::Real = -20.0, hist_end::Real = 5.0, bin_width::Real = 0.05; aoe_expression::Union{Symbol, String}="aoe", qdrift_expression::Union{Symbol, String} = "qdrift / e", pseudo_prior::NamedTupleDist = NamedTupleDist(empty = true), pseudo_prior_all::NamedTupleDist = NamedTupleDist(empty = true), pol_order::Int=1)
99
1010
Correct for the drift time dependence of A/E parameter
1111
12-
# Returns (but may change):
12+
13+
# Arguments
14+
* `aoe_all`: All A/E values
15+
* `ecal_all`: All calibrated energies
16+
* `qdrift_e_all`: All charge drift energy
17+
* `compton_bands`: Compton bands
18+
* `peak`: Peak position
19+
* `window`: Window size
20+
* `hist_start`: Histogram start position
21+
* `hist_end`: Histogram end position
22+
* `bin_width`: Bin width
23+
24+
# Keywords
25+
* `aoe_expression`: A/E expression
26+
* `qdrift_expression`: Charge drift expression
27+
* `pseudo_prior`: Pseudo prior
28+
* `peudo_prior_all`: All pseudo priors
29+
* `pol_order`: Polynomial order
30+
31+
# Returns
1332
* `peak`: peak position
1433
* `window`: window size
34+
* `func`: function to correct aoe
1535
* `fct`: correction factor
1636
* `σ_before`: σ before correction
1737
* `σ_after`: σ after correction
18-
* `func`: function to correct aoe
19-
* `func_generic`: generic function to correct aoe
38+
* `converged`: Convergence status of the fit
2039
"""
2140

2241
function ctc_aoe(aoe_all::Vector{<:Real}, ecal_all::Vector{<:Unitful.RealOrRealQuantity}, qdrift_e_all::Vector{<:Real}, compton_bands::Vector{<:Unitful.RealOrRealQuantity}, peak::Real = 0.0, window::Tuple{<:Real, <:Real} = (50.0, 8.0), hist_start::Real = -20.0, hist_end::Real = 5.0, bin_width::Real = 0.05; aoe_expression::Union{Symbol, String}="aoe", qdrift_expression::Union{Symbol, String} = "qdrift / e", pseudo_prior::NamedTupleDist = NamedTupleDist(empty = true), pseudo_prior_all::NamedTupleDist = NamedTupleDist(empty = true), pol_order::Int=1) # deleted m_cal since no calibration

Diff for: src/aoe_cut.jl

+98-19
Original file line numberDiff line numberDiff line change
@@ -4,8 +4,21 @@
44
55
Get the survival fraction after a AoE cut value `aoe_cut` for a given `peak` and `window` size from a combined fit to the survived and cut histograms.
66
7+
# Arguments
8+
* `aoe_cut`: A/E cut value
9+
* `aoe`: A/E
10+
* `e`: Calibrated energies
11+
* `peak`: Peak position
12+
* `window`: Data window in energy
13+
* `bin_width`: Histogram bin widths
14+
* `result_before`: Survival fraction before A/E cut
15+
16+
# Keywords
17+
* `uncertainty`: Uncertainty of survival fraction
18+
* `fit_func`: Fit function
19+
720
# Returns
8-
- `sf`: Survival fraction after the cut
21+
* `result.sf`: Survival fraction after the cut
922
"""
1023
function get_sf_after_aoe_cut(aoe_cut::Unitful.RealOrRealQuantity, aoe::Vector{<:Unitful.RealOrRealQuantity}, e::Vector{<:T}, peak::T, window::Vector{T}, bin_width::T, result_before::NamedTuple; uncertainty::Bool=true, fit_func::Symbol=:gamma_def) where T<:Unitful.Energy{<:Real}
1124
# get energy after cut and create histogram
@@ -25,12 +38,35 @@ export get_sf_after_aoe_cut
2538
cut_search_interval::Tuple{<:Unitful.RealOrRealQuantity, <:Unitful.RealOrRealQuantity}=(-25.0*unit(first(aoe)), 1.0*unit(first(aoe))),
2639
bin_width_window::T=3.0u"keV", max_e_plot::T=3000.0u"keV", plot_window::Vector{<:T}=[12.0, 50.0]u"keV",
2740
fixed_position::Bool=true, fit_func::Symbol=:gamma_def, uncertainty::Bool=true) where T<:Unitful.Energy{<:Real}
41+
2842
Get the AoE cut value for a given `dep` and `window` size while performing a peak fit with fixed position. The AoE cut value is determined by finding the cut value for which the number of counts after the cut is equal to `dep_sf` times the number of counts before the cut.
2943
The algorhithm utilizes a root search algorithm to find the cut value with a relative tolerance of `rtol`.
44+
45+
# Arguments
46+
* `aoe`: A/E
47+
* `e`: Calibrated energies
48+
49+
# Keywords
50+
* `dep`: DEP energies
51+
* `window`: Data window in energy
52+
* `dep_sf`: Survival fraction of DEP energies
53+
* `rtol`: Relative tolerance
54+
* `maxiters`: Maximum iterations
55+
* `sigma_high_sided`: Fixed upper limit cut
56+
* `cut_search_interval`: Data interval to search for a cut value
57+
* `bin_width_window`: Specified window around the peak in which the bin algorithm is applied
58+
* `max_e_plot`: Maximum energy plot
59+
* `plot_window`: Plot window
60+
* `fixed_position`: Fixed position of cut
61+
* `fit_func`: Fitted function
62+
* `uncertainty`: Uncertainty
63+
3064
# Returns
31-
- `cut`: AoE cut value
32-
- `n0`: Number of counts before the cut
33-
- `nsf`: Number of counts after the cut
65+
* `lowcut`: low AoE cut value
66+
* `highcut`: high AoE cut value
67+
* `n0`: Number of counts before the cut
68+
* `nsf`: Number of counts after the cut
69+
* `sf`: Survival fraction
3470
"""
3571
function get_low_aoe_cut(aoe::Vector{<:Unitful.RealOrRealQuantity}, e::Vector{<:T},;
3672
dep::T=1592.53u"keV", window::Vector{<:T}=[12.0, 10.0]u"keV", dep_sf::Float64=0.9, rtol::Float64=0.001, maxiters::Int=300, sigma_high_sided::Float64=Inf,
@@ -91,9 +127,25 @@ export get_low_aoe_cut
91127
get_peaks_survival_fractions(aoe::Vector{<:Unitful.RealOrRealQuantity}, e::Vector{<:T}, peaks::Vector{<:T}, peak_names::Vector{Symbol}, windows::Vector{<:Tuple{T, T}}, aoe_cut::Unitful.RealOrRealQuantity,; uncertainty::Bool=true, inverted_mode::Bool=false, bin_width_window::T=2.0u"keV", sigma_high_sided::Unitful.RealOrRealQuantity=Inf*unit(first(aoe)), fit_funcs::Vector{Symbol}=fill(:gamma_def, length(peaks))) where T<:Unitful.Energy{<:Real}
92128
93129
Get the survival fraction of a peak after a AoE cut value `aoe_cut` for a given `peak` and `window` size while performing a peak fit with fixed position.
130+
131+
# Arguments
132+
* `aoe`: A/E
133+
* `e`: Calibrated energies
134+
* `peaks`: Data range of several peaks
135+
* `peak_names`: Name of the peak
136+
* `windows`: Energy data window
137+
* `aoe_cut`: A/E cut value
138+
139+
# Keywords
140+
* `uncertainty`: Uncertainty
141+
* `inverted_mode`: If set to false: A/E analysis. If True: LQ analysis
142+
* `bin_width_window`: Specified window around the peak where the binning algorithm is applied to
143+
* `sigma_high_sided`: Fixed upper limit cut
144+
* `fit_funcs`: Fitted functions
145+
94146
# Return
95-
- `result`: Dict of results for each peak
96-
- `report`: Dict of reports for each peak
147+
* `result`: Dict of results for each peak
148+
* `report`: Dict of reports for each peak
97149
"""
98150
function get_peaks_survival_fractions(aoe::Vector{<:Unitful.RealOrRealQuantity}, e::Vector{<:T}, peaks::Vector{<:T}, peak_names::Vector{Symbol}, windows::Vector{<:Tuple{T, T}}, aoe_cut::Unitful.RealOrRealQuantity,; uncertainty::Bool=true, inverted_mode::Bool=false, bin_width_window::T=2.0u"keV", sigma_high_sided::Unitful.RealOrRealQuantity=Inf*unit(first(aoe)), fit_funcs::Vector{Symbol}=fill(:gamma_def, length(peaks))) where T<:Unitful.Energy{<:Real}
99151
@assert length(peaks) == length(peak_names) == length(windows) "Length of peaks, peak_names and windows must be equal"
@@ -125,16 +177,31 @@ export get_peaks_survival_fractions, get_peaks_surrival_fractions
125177

126178
"""
127179
get_peak_survival_fraction(aoe::Vector{<:Unitful.RealOrRealQuantity}, e::Vector{<:T}, peak::T, window::Vector{T}, aoe_cut::Unitful.RealOrRealQuantity,;
128-
uncertainty::Bool=true, inverted_mode::Bool=false, bin_width_window::T=2.0u"keV", sigma_high_sided::Unitful.RealOrRealQuantity=Inf*unit(first(aoe)), fit_func::Symbol=:gamma_def) where T<:Unitful.Energy{<:Real}
180+
uncertainty::Bool=true, inverted_mode::Bool=false, bin_width_window::T=2.0u"keV", sigma_high_sided::Unitful.RealOrRealQuantity=Inf*unit(first(aoe)), fit_func::Symbol=:gamma_def) where T<:Unitful.Energy{<:Real}
129181
130182
Get the survival fraction of a peak after a AoE cut value `aoe_cut` for a given `peak` and `window` size while performing a peak fit with fixed position.
131183
184+
# Arguments
185+
* `aoe`: A/E
186+
* `e`: Calibrated energies
187+
* `peak`: Peak position
188+
* `window`: Data window in energy
189+
* `aoe_cut`: A/E cut value
190+
191+
# Keywords
192+
* `Uncertainty`: Uncertainty
193+
* `lq_mode`: Inverts the cut logic
194+
* `low_e_tail`: Low energy tail
195+
* `bin_width_window`: Specified window around the peak to apply the binning algorithm
196+
* `sigma_high_sided`: Fixed upper limit cut
197+
132198
# Returns
133-
- `peak`: Peak position
134-
- `n_before`: Number of counts before the cut
135-
- `n_after`: Number of counts after the cut
136-
- `sf`: Survival fraction
137-
- `err`: Uncertainties
199+
* `peak`: Peak position
200+
* `fit_func`: fitted function
201+
* `n_before`: Number of counts before the cut
202+
* `n_after`: Number of counts after the cut
203+
* `sf`: Survival fraction
204+
* `gof`: Goodness of fit
138205
"""
139206
function get_peak_survival_fraction(aoe::Vector{<:Unitful.RealOrRealQuantity}, e::Vector{<:T}, peak::T, window::Vector{T}, aoe_cut::Unitful.RealOrRealQuantity,;
140207
uncertainty::Bool=true, inverted_mode::Bool=false, bin_width_window::T=2.0u"keV", sigma_high_sided::Unitful.RealOrRealQuantity=Inf*unit(first(aoe)), fit_func::Symbol=:gamma_def) where T<:Unitful.Energy{<:Real}
@@ -189,17 +256,29 @@ export get_peak_survival_fraction, get_peak_surrival_fraction
189256

190257

191258
"""
192-
get_continuum_survival_fraction(aoe::Vector{<:Unitful.RealOrRealQuantity}, e::Vector{<:T}, center::T, window::T, aoe_cut::Unitful.RealOrRealQuantity,; inverted_mode::Bool=false, sigma_high_sided::Unitful.RealOrRealQuantity=Inf*unit(first(aoe))) where T<:Unitful.Energy{<:Real}
259+
get_continuum_survival_fraction(aoe::Vector{<:Unitful.RealOrRealQuantity}, e::Vector{<:T}, center::T, window::T, aoe_cut::Unitful.RealOrRealQuantity; inverted_mode::Bool=false, sigma_high_sided::Unitful.RealOrRealQuantity=Inf*unit(first(aoe))) where T<:Unitful.Energy{<:Real}
260+
193261
Get the survival fraction of a continuum after a AoE cut value `aoe_cut` for a given `center` and `window` size.
194262
263+
# Arguments
264+
* `aoe`: A/E
265+
* `e`: Calibrated energies
266+
* `center`: Center of the fit
267+
* `window`: Data window in energy
268+
* `aoe_cut`: A/E cut value
269+
270+
# Keywords
271+
* `inverted_mode`: Inverted cut logic
272+
* `sigma_high_sided`: Fixed upper limit cut
273+
195274
# Returns
196-
- `center`: Center of the continuum
197-
- `window`: Window size
198-
- `n_before`: Number of counts before the cut
199-
- `n_after`: Number of counts after the cut
200-
- `sf`: Survival fraction
275+
* `window`: Window size
276+
* `n_before`: Number of counts before the cut
277+
* `n_after`: Number of counts after the cut
278+
* `sf`: Survival fraction
279+
201280
"""
202-
function get_continuum_survival_fraction(aoe::Vector{<:Unitful.RealOrRealQuantity}, e::Vector{<:T}, center::T, window::T, aoe_cut::Unitful.RealOrRealQuantity,; inverted_mode::Bool=false, sigma_high_sided::Unitful.RealOrRealQuantity=Inf*unit(first(aoe))) where T<:Unitful.Energy{<:Real}
281+
function get_continuum_survival_fraction(aoe::Vector{<:Unitful.RealOrRealQuantity}, e::Vector{<:T}, center::T, window::T, aoe_cut::Unitful.RealOrRealQuantity; inverted_mode::Bool=false, sigma_high_sided::Unitful.RealOrRealQuantity=Inf*unit(first(aoe))) where T<:Unitful.Energy{<:Real}
203282
# scale unit
204283
e_unit = u"keV"
205284
# get energy around center

Diff for: src/aoe_filter_optimization.jl

+48-10
Original file line numberDiff line numberDiff line change
@@ -1,12 +1,24 @@
11

22

33
"""
4-
prepare_sep_peakhist(e::Array{T}, dep::T,; relative_cut::T=0.5, n_bins_cut::Int=500) where T<:Real
4+
prepare_sep_peakhist(e::Vector{<:T}; sep::Unitful.Energy{<:Real}=2103.53u"keV", window::Vector{<:Unitful.Energy{<:Real}}=[25.0, 25.0]u"keV", relative_cut::T=0.5, n_bins_cut::Int=-1, fit_func::Symbol=:gamma_def, uncertainty::Bool=true) where T<:Real
55
66
Prepare an array of uncalibrated SEP energies for parameter extraction and calibration.
7+
8+
# Arguments
9+
* `e`: Uncalibrated energies
10+
11+
# Keywords
12+
* `sep`: Single escape peak
13+
* `window`: Energy window
14+
* `relative_cut`: Relative cut
15+
* `n_bins_cut`: Number of cut bins
16+
* `fit_func`: fitted function
17+
* `uncertainty`: Uncertainty
18+
:
719
# Returns
8-
- `result`: Result of the initial fit
9-
- `report`: Report of the initial fit
20+
* `result`: Result of the initial fit
21+
* `report`: Report of the initial fit
1022
"""
1123
function prepare_sep_peakhist(e::Vector{<:T}; sep::Unitful.Energy{<:Real}=2103.53u"keV", window::Vector{<:Unitful.Energy{<:Real}}=[25.0, 25.0]u"keV", relative_cut::T=0.5, n_bins_cut::Int=-1, fit_func::Symbol=:gamma_def, uncertainty::Bool=true) where T<:Real
1224
# get cut window around peak
@@ -27,18 +39,44 @@ function prepare_sep_peakhist(e::Vector{<:T}; sep::Unitful.Energy{<:Real}=2103.5
2739
end
2840

2941
"""
30-
fit_sf_wl(dep_sep_data, a_grid_wl_sg, optimization_config)
42+
fit_sf_wl(e_dep::Vector{<:Real}, aoe_dep::ArrayOfSimilarArrays{<:Real}, e_sep::Vector{<:Real}, aoe_sep::ArrayOfSimilarArrays{<:Real}, a_grid_wl_sg::StepRangeLen;
43+
dep::T=1592.53u"keV", dep_window::Vector{<:T}=[12.0, 10.0]u"keV",
44+
sep::T=2103.53u"keV", sep_window::Vector{<:T}=[25.0, 25.0]u"keV", sep_rel_cut::Real=0.5,
45+
min_aoe_quantile::Real=0.1, max_aoe_quantile::Real=0.99,
46+
min_aoe_offset::Quantity{<:Real}=0.0u"keV^-1", max_aoe_offset::Quantity{<:Real}=0.05u"keV^-1",
47+
dep_cut_search_fit_func::Symbol=:gamma_def, sep_cut_search_fit_func::Symbol=:gamma_def,
48+
uncertainty::Bool = false) where T<:Unitful.Energy{<:Real}
3149
3250
Fit a A/E filter window length for the SEP data and return the optimal window length and the corresponding survival fraction.
3351
3452
# Arguments
35-
- `dep_sep_data`: NamedTuple with the DEP and SEP data
36-
- `a_grid_wl_sg`: range of window lengths to sweep through
37-
- `optimization_config`: configuration dictionary
53+
* `e_dep`: DEP energy
54+
* `aoe_dep`: Double escape peak A/E
55+
* `e_sep`: SEP energy
56+
* `aoe_sep`: Single escape peak A/E
57+
* `a_grid_wl_sg`: Range of window lengths to sweep through
58+
59+
# Keywords
60+
* `dep`: Double escape peak
61+
* `dep_window`: DEP window
62+
* `sep`: Single escape peak
63+
* `sep_window`: SEP window
64+
* `sep_rel_cut`: SEP relative cut
65+
* `min_aoe_quantile`: Minimum A/E quantile
66+
* `max_aoe_quantile`: Maximum A/E quantile
67+
* `min_aoe_offset`: Minimum A/E offset
68+
* `max_aoe_offset`: Maximum A/E offset
69+
* `dep_cut_search_fit_func`: Symbol describing the function for the DEP cut search
70+
* `sep_cut_search_fit_func`: Symbol describing the function for the SEP cut search
71+
* `uncertainty`: Uncertainty
72+
3873
3974
# Returns
40-
- `result`: optimal window length and corresponding survival fraction
41-
- `report`: report with all window lengths and survival fractions
75+
* `wl`: Window length
76+
* `sf`: Survival fraction
77+
* `n_dep`: Number of DEP energies
78+
* `n_sep`: Number of SEP energies
79+
4280
"""
4381
function fit_sf_wl(e_dep::Vector{<:Real}, aoe_dep::ArrayOfSimilarArrays{<:Real}, e_sep::Vector{<:Real}, aoe_sep::ArrayOfSimilarArrays{<:Real}, a_grid_wl_sg::StepRangeLen;
4482
dep::T=1592.53u"keV", dep_window::Vector{<:T}=[12.0, 10.0]u"keV",
@@ -62,7 +100,7 @@ function fit_sf_wl(e_dep::Vector{<:Real}, aoe_dep::ArrayOfSimilarArrays{<:Real},
62100
sep_sfs = Vector{Quantity}(undef, length(a_grid_wl_sg))
63101
wls = Vector{eltype(a_grid_wl_sg)}(undef, length(a_grid_wl_sg))
64102

65-
# for each window lenght, calculate the survival fraction in the SEP
103+
# for each window length, calculate the survival fraction in the SEP
66104
Threads.@threads for i_aoe in eachindex(a_grid_wl_sg)
67105
# get window length
68106
wl = a_grid_wl_sg[i_aoe]

Diff for: src/aoe_fit_calibration.jl

+16-8
Original file line numberDiff line numberDiff line change
@@ -1,17 +1,25 @@
11
@. f_aoe_sigma(x, p) = sqrt(p[1]^2 + p[2]^2/x^2)
22
f_aoe_mu(x, p) = p[1] .+ p[2].*x
33
"""
4-
fit_aoe_corrections(e::Array{<:Unitful.Energy{<:Real}}, μ::Array{<:Real}, σ::Array{<:Real})
4+
fit_aoe_corrections(e::Array{<:Unitful.Energy{<:Real}}, μ::Array{<:Real}, σ::Array{<:Real}; aoe_expression::Union{String,Symbol}="a / e", e_expression::Union{String,Symbol}="e")
55
66
Fit the corrections for the AoE value of the detector.
7+
8+
# Arguments
9+
* `e`: Calibrated energies
10+
* `μ`: Mean values
11+
* `σ`: Sigma values
12+
13+
# Keywords
14+
* `aoe_expression`: A/E expression
15+
* `e_expression`: Calibrated energy expression
16+
717
# Returns
8-
- `e`: Energy values
9-
- `μ`: Mean values
10-
- `σ`: Sigma values
11-
- `μ_scs`: Fit result for the mean values
12-
- `f_μ_scs`: Fit function for the mean values
13-
- `σ_scs`: Fit result for the sigma values
14-
- `f_σ_scs`: Fit function for the sigma values
18+
* `µ_compton`: Mean compton values
19+
* `σ_compton`: Sigma compton values
20+
* `compton_bands`: Compton bands
21+
* `func`: A/E correction function
22+
1523
"""
1624
function fit_aoe_corrections(e::Array{<:Unitful.Energy{<:Real}}, μ::Array{<:Real}, σ::Array{<:Real}; aoe_expression::Union{String,Symbol}="a / e", e_expression::Union{String,Symbol}="e")
1725
# fit compton band mus with linear function

Diff for: src/aoe_pseudo_prior.jl

+34
Original file line numberDiff line numberDiff line change
@@ -1,3 +1,20 @@
1+
"""
2+
get_aoe_standard_pseudo_prior(h::Histogram, ps::NamedTuple, fit_func::Symbol; fixed_position::Bool=false)
3+
4+
Gets the A/E of a histogram using a standard pseudo prior.
5+
6+
# Arguments
7+
* `h`: Histogram data
8+
* `ps`: Peak statistics
9+
* `fit_func`: Fit function
10+
11+
# Keywords
12+
* `fixed_position`: Determines whether the function uses a fixed position or not
13+
14+
# Returns
15+
* `pprior_base`: Base pseudo prior
16+
"""
17+
118
function get_aoe_standard_pseudo_prior(h::Histogram, ps::NamedTuple, fit_func::Symbol; fixed_position::Bool=false)
219
pprior_base = NamedTupleDist(
320
μ = ifelse(fixed_position, ConstValueDist(ps.peak_pos), Normal(ps.peak_pos, 0.5*ps.peak_sigma)),
@@ -25,6 +42,23 @@ function get_aoe_standard_pseudo_prior(h::Histogram, ps::NamedTuple, fit_func::S
2542
end
2643
end
2744

45+
"""
46+
get_aoe_pseudo_prior(h::Histogram, ps::NamedTuple, fit_func::Symbol; pseudo_prior::NamedTupleDist=NamedTupleDist(empty = true), kwargs...)
47+
48+
Gets the A/E of a histogram using a pseudo prior.
49+
# Arguments
50+
* `h`: Histogram data
51+
* `ps`: Peak statistics
52+
* `fit_func`: Fit function
53+
54+
# Keywords
55+
* `pseudo_prior`: Initial guess for parameters of histogram
56+
57+
# Returns
58+
* `pseudo_prior`: Initial guess for parameters of histogram
59+
60+
"""
61+
2862
function get_aoe_pseudo_prior(h::Histogram, ps::NamedTuple, fit_func::Symbol; pseudo_prior::NamedTupleDist=NamedTupleDist(empty = true), kwargs...)
2963
standard_pseudo_prior = get_aoe_standard_pseudo_prior(h, ps, fit_func; kwargs...)
3064
# use standard priors in case of no overwrites given

0 commit comments

Comments
 (0)