Purpose\n\nramanchada2
software package is meant to fill the gap between the theoretical\nRaman analysis and the experimental Raman spectroscopy by providing means to\ncompare data of different origin. The software is in early development stage\nbut still able to solve practical problems.
\n\nFeatures
\n\nRead simulated data
\n\nProcess simulated data by VASP and CRYSTAL and provide same interface.\nCRYSTAL data contain intensities for multiple orientations -- laser beam\nincidents perpendicularly or parallelly to the observation and information\nfor mono-crystals. VASP data provide data only for poly-crystals but in\ndifferent format. So the perpendicular and parallel intensities are calculated\nby an implemented algorithm.
\n\nModels
\n\nLMFIT theoretical models can be build by spectral information obtained by\nsimulations or by provided by the user. These models can be fit to experimental\ndata, providing calibration information. At poor initial calibration the minimisation\nprocedure naturally fails. An iterative procedure aiming to solve this problem\nwas adopted in the code. On the first iteration the experimental spectrum lines\nare artificially broadened. This makes it possible for the minimisation procedure\nto find a parameters that are close enough to be used as an initial guess for\nthe second iteration. In few iterations the algorithm is able to fit to the original\nexperimental data. This idea is implemented and is at proof-of-concept level.
\n\nGenerate spectra
\n\nSpectra can be generated by the theoretical models. Random Poissonian noise and\nartificial random-generated baseline can be added to the generated spectra, making\nthem convenient tools to test new methods for analysis.
\n\nSpectrum manipulation
\n\nA number of filters can be applied to spectra (experimental and generated).\nScaling on both x and y axes is possible. Scaling could be linear or arbitrary\nuser defined function. A convolution is possible with set of predefined functions\nas well as user defined model.
\n\nConcept
\n\nThe code is object oriented, written in python. Main elements are Spectrum and\ntheoretical models. Theoretical models are based on LMFIT library, while\nSpectrum is a custom made class. Spectrum object contains data for x and y axes\nand metadata coming from experimental files or other sources. It is planned\nto add information about the uncertainties in x and y. All filters and manipulation\nprocedures are available as class methods. Measures are taken to preserve spectrum\ninstances immutable, so filters are generating new spectra, preserving the original\nunchanged. Additionally, Spectrum has information about its history -- the sequence\nof applied filters.
\n\n\n\n.cha
\n\nramanchada software package introduced .cha
file format, which is an HDF5\nwith a simple layout.
\n\nCache in .cha files
\n\nThe concept to keep previous variants of data is employed in ramanchada2
. If\nconfigured so, the software saves the data for all Spectrum instances to a\ntree-organized .cha
file. When a particular chain of operations is requested\nby the user, the software checks if the final result is present in the cache file,\nif so it is provided, otherwise the software checks for its parent. When a parent\nor some of the grand parents are present, they are taken as a starting point and\nthe needed steps are applied to provide the final result. The current implementation\nuses h5py library to access local hdf files. It is foreseen to have implementation\nwith h5pyd that support network operations.
\n\n\n\nThe latest ramanchada2 package allows export of a spectrum to NeXus format.
\n\nDecorated Functions in Spectrum
\n\nFunction: __add__
\n\nDocstring: No docstring available
\n\n
\n\nFunction: __init__
\n\nDocstring: No docstring available
\n\n
\n\nFunction: __mul__
\n\nDocstring: No docstring available
\n\n
\n\nFunction: __sub__
\n\nDocstring: No docstring available
\n\n
\n\nFunction: __truediv__
\n\nDocstring: No docstring available
\n\n
\n\nFunction: abs_nm_to_shift_cm_1
\n\nDocstring: \n Convert wavelength to Ramanshift in wavenumber
\n\nArgs:\n spe: internal use only\n laser_wave_length_nm: Laser wave length\n\nReturns: Corrected x-values\n
\n\n
\n\nFunction: abs_nm_to_shift_cm_1_filter
\n\nDocstring: \n Convert wavelength to Ramanshift in wavenumber
\n\nArgs:\n spe: internal use only\n laser_wave_length_nm: Laser wave length\n\nReturns: Spectrum with corrected x-values\n
\n\n
\n\nFunction: add_baseline
\n\nDocstring: \n Add artificial baseline to the spectrum.\n A random baseline is generated in frequency domain using uniform random numbers.\n The baseline in frequency domain is tapered with bohman window to reduce the bandwidth\n of the baseline to first n_freq
frequencies and is transformed to \"time\" domain.\n Additionaly by using func
parameter the user can define arbitrary function\n to be added as baseline.
\n\nArgs:\n n_freq:\n Must be `> 2`. Number of lowest frequency bins distinct from zero.\n amplitude:\n Upper boundary for the uniform random generator.\n pedestal:\n Additive constant pedestal to the spectrum.\n func:\n Callable. User-defined function to be added as baseline. Example: `func = lambda x: x*.01 + x**2*.0001`.\n rng_seed:\n `int`, optional. Seed for the random generator.\n
\n\n
\n\nFunction: add_gaussian_noise
\n\nDocstring: \n Add gaussian noise to the spectrum.
\n\nRandom number i.i.d. $N(0, \\sigma)$ is added to every sample\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n sigma:\n Sigma of the gaussian noise.\n rng_seed:\n `int` or rng state, optional, seed for the random generator.\n If a state is provided, it is updated in-place.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: add_gaussian_noise_drift
\n\nDocstring: \n Add cumulative gaussian noise to the spectrum.
\n\nExponential-moving-average-like gaussian noise is added\nto each sample. The goal is to mimic the low-frequency noise\n(or random substructures in spectra).\nThe additive noise is\n$$a_i = coef*\\sum_{j=0}^{i-1}g_j + g_i,$$\n\nwhere\n$$g_i = \\mathcal{N}(0, 1+\\frac{coef}{\\sqrt 2}).$$\n\nThis way drifting is possible while keeping the\n$$\\sigma(\\Delta(a)) \\approx 1.$$\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n sigma:\n Sigma of the gaussian noise.\n coef:\n `float` in `[0, 1]`, drifting coefficient. If `coef == 0`,\n the result is identical to `add_gaussian_noise()`.\n rng_seed:\n `int` or rng state, optional. Seed for the random generator.\n If a state is provided, it is updated in-place.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: add_poisson_noise
\n\nDocstring: \n Add poisson noise to the spectrum.
\n\nFor each particular sample the noise is proportional to $\\sqrt{scale*a_i}$.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n scale:\n `float`, optional, default is `1`. Scale the amplitude of the noise.\n rng_seed:\n `int` or rng state, optional. Seed for the random generator.\n If a state is provided, it is updated in-place.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: apply_processing
\n\nDocstring: No docstring available
\n\n
\n\nFunction: bayesian_gaussian_mixture
\n\nDocstring: \n Decompose the spectrum to Bayesian Gaussian Mixture
\n\nArgs:\n spe: internal use only\n n_samples: optional. Defaults to 5000.\n Resampled dataset size\n n_components: optional. Defaults to 50.\n Number of expected gaussian components\n max_iter: optional. Defaults to 100.\n Maximal number of iterations.\n moving_minimum_window: optional. Defaults to None.\n If None no moving minimum is subtracted, otherwise as specified.\n random_state: optional. Defaults to None.\n Random generator seed to be used.\n trim_range: optional. Defaults to None:\n If None ignore trimming, otherwise trim range is in x-axis values.\n\nReturns:\n BayesianGaussianMixture: Fitted Bayesian Gaussian Mixture\n
\n\n
\n\nFunction: calibrate_by_deltas_filter
\n\nDocstring: No docstring available
\n\n
\n\nFunction: calibrate_by_deltas_model
\n\nDocstring: \n - Builds a composite model based on a set of user specified delta lines.\n - Initial guess is calculated based on 10-th and 90-th percentiles of\n the distributions.
\n\nThe phasespace of the model is flat with big amount of narrow minima.\nIn order to find the best fit, the experimental data are successively\nconvolved with gaussians with different widths startign from wide to\nnarrow. The model for the calibration is 3-th order polynomial, which\npotentialy can be changed for higher order polynomial. In order to avoid\nsolving the inverse of the calibration function, the result is tabulated\nand interpolated linarly for each bin of the spectrum.\nThis alogrithm is useful for corse calibration.\n
\n\n
\n\nFunction: central_moments
\n\nDocstring: No docstring available
\n\n
\n\nFunction: convolve
\n\nDocstring: \n Convole spectrum with arbitrary lineshape.
\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n lineshape:callable, `str` or `np.ndarray`.\n If callable: should have a single positional argument `x`, e.g.\n `lambda x: np.exp((x/5)**2)`.\n If predefined peak profile: can be `gaussian`, `lorentzian`, `voigt`,\n `pvoigt`, `moffat` or `pearson4`.\n If `np.ndarray`: lineshape in samples.\n **kwargs:\n Additional kwargs will be passed to lineshape function.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: derivative_sharpening
\n\nDocstring: \n Derivative-based sharpening.
\n\nSharpen the spectrum subtracting second derivative and add fourth derivative.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n filter_fraction `float` in (0; 1]: Default is 0.6\n Depth of filtration\n signal_width: The width of features to be enhanced in sample count\n der2_factor: Second derivative scaling factor\n der4_factor: Fourth derivative scaling factor\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: drop_spikes
\n\nDocstring: \n Removes single-bin spikes.
\n\nRemove x, y pairs recognised as spikes using left and right\nsuccessive differences and standard-deviation-based threshold.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n n_sigma: optional, default is `10`.\n Threshold is `n_sigma` times the standard deviation.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: dropna
\n\nDocstring: \n Remove non finite numbers on both axes
\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: find_peak_multipeak
\n\nDocstring: \n Find groups of peaks in spectrum.
\n\nArgs:\n spe: internal use only\n prominence: Optional. Defaults to None\n If None the prominence value will be `spe.y_nose`. Reasonable value for\n promience is `const * spe.y_noise_MAD`.\n wlen: optional. Defaults to None.\n wlen value used in `scipy.signal.find_peaks`. If wlen is None, 200 will be used.\n width: optional. Defaults to None.\n width value used in `scipy.signal.find_peaks`. If width is None, 2 will be used.\n hht_chain: optional. Defaults to None.\n List of hht_chain window sizes. If None, no hht sharpening is performed.\n bgm_kwargs: kwargs for bayesian_gaussian_mixture\n sharpening 'hht' or None. Defaults to None.\n If 'hht' hht sharpening will be performed before finding peaks.\n strategy: optional. Defauts to 'topo'.\n Peakfinding method\n\nReturns:\n ListPeakCandidateMultiModel: Located peak groups\n
\n\n
\n\nFunction: find_peak_multipeak_filter
\n\nDocstring: \n Same as find_peak_multipeak
but the result is stored as metadata in the returned spectrum.
\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n *args, **kwargs: same as `find_peak_multipeak`\n
\n\n
\n\nFunction: fit_peak_multimodel
\n\nDocstring: No docstring available
\n\n
\n\nFunction: fit_peak_positions
\n\nDocstring: \n Calculate peak positions and amplitudes.
\n\nSequence of multiple processings:\n- `subtract_moving_minimum`\n- `find_peak_multipeak`\n- filter peaks with x-location better than threshold\n\nArgs:\n spe: internal use only\n mov_min: optional. Defaults to 40\n subtract moving_minimum with the specified window.\n center_err_threshold: optional. Defaults to 0.5.\n threshold for centroid standard deviation. Only peaks\n with better uncertainty will be returned.\n\n find_peaks_kw: optional\n keyword arguments to be used with find_peak_multipeak\n fit_peaks_kw: optional\n keyword arguments to be used with fit_peaks_multipeak\n\nReturns:\n Dict[float, float]: {positions: amplitudes}\n
\n\n
\n\nFunction: fit_peaks_filter
\n\nDocstring: \n Same as fit_peak_multipeak
but the result is stored as metadata in the returned spectrum.
\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n should_break: same as in fit_peaks_multipeak\n *args, **kwargs: same as `fit_peaks_multipeak`\n
\n\n
\n\nFunction: from_cache_or_calc
\n\nDocstring: \n Load spectrum from cache or calculate if needed.
\n\nThe cache is a nested structure of spectra. All processings applied to\na spectrum result to spectra of the initial one. If part of the requred\nprocessings are available, only the needed steps are calculated and added\nto the cache.\n\nArgs:\n required_steps: List of required steps in the form\n [{'proc': str, 'args': List[Any], 'kwargs': Dict[str, Any]}, ...]\n cachefile: optional. Defaults to None.\n Filename of the cache. If None no cache is used\n
\n\n
\n\nFunction: from_chada
\n\nDocstring: No docstring available
\n\n
\n\nFunction: from_delta_lines
\n\nDocstring: \n Generate Spectrum
with delta lines.
\n\nArgs:\n deltas:\n Keys of the dictionary are the `x` positions of the deltas; values are the amplitudes of the corresponding\n deltas.\n xcal:\n Callable, optional. `x` axis calibration function.\n nbins:\n `int`, optional. Number of bins in the spectrum.\n xaxis:\n `Array-like`, optional. The xaxis of the new spectrum. If `xaxis` is provided,\n `xcal` should be `None` and `nbins` is ignored.\n\nExample:\n\nThis will produce spectrum with 1000 bins in the range `[-1000, 2000)`:\n\n\n\n
xcal = lambda x: x*3 -1000, nbins=1000\n
\n
\n
\n\n
\n\nFunction: from_local_file
\n\nDocstring: \n Read experimental spectrum from a local file.
\n\nArgs:\n in_file_name:\n Path to a local file containing a spectrum.\n filetype:\n Specify the filetype. Filetype can be any of: `spc`, `sp`, `spa`, `0`, `1`, `2`, `wdf`, `ngs`, `jdx`, `dx`,\n `txt`, `txtr`, `csv`, `prn`, `rruf`, `spe` (Princeton Instruments) or `None`.\n `None` used to determine by extension of the file.\n backend:\n `native`, `rc1_parser` or `None`. `None` means both.\n\nRaises:\n ValueError:\n When called with unsupported file formats.\n
\n\n
\n\nFunction: from_simulation
\n\nDocstring: \n Generate spectrum from simulation file.
\n\nThe returned spectrum has only few x/y pairs -- one for each simulated line. Values along\nthe x-axis will not be uniform. To make it uniform, one needs to resample the spectrum.\n\nArgs:\n in_file:\n Path to a local file, or file-like object.\n sim_type:\n If `vasp`: `.dat` file from VASP simulation. If `crystal_out`: `.out` file from CRYSTAL simulation, not\n preferred. If `crystal_dat`: `.dat` file from CRYSTAL simulation.\n use:\n One of the directions `I_tot`, `I_perp`, `I_par`, `I_xx`, `I_xy`,\n `I_xz`, `I_yy`, `I_yz`, `I_zz`, `I_tot`, `I_perp`, `I_par` are\n available for both CRYSTAL and VASP. `I_xx`, `I_xy`, `I_xz`,\n `I_yy`, `I_yz`, `I_zz` are available only for CRYSTAL. If a Dict is\n passed, the key should be directions and values should be weighting factor.\n For example, `use={'I_perp': .1, 'I_par': .9}`\n
\n\n
\n\nFunction: from_spectral_component_collection
\n\nDocstring: \n from_spectral_component_collection
\n\nArgs:\n spe_components:\n SpectralComponentCollection\n x:\n `int` or array-like, optional, default `2000`. `x` axis of the spectrum.\n
\n\n
\n\nFunction: from_stream
\n\nDocstring: No docstring available
\n\n
\n\nFunction: from_test_spe
\n\nDocstring: Create new spectrum from test data.
\n\nArgs:\n index:\n `int` or `None`, optional, default is `None`. If `int`: will be used as an index of filtered list. If\n `None`: a random spectrum will be taken.\n **kwargs:\n The rest of the parameters will be used as filter.\n
\n\n
\n\nFunction: from_theoretical_lines
\n\nDocstring: \n Generate spectrum from lmfit
shapes.
\n\nArgs:\n shapes:\n The shapes to be used for spectrum generation.\n params:\n Shape parameters to be applied to be used with shapes.\n x:\n Array with `x` values, by default `np.array(2000)`.\n
\n\n
\n\nFunction: gen_samples
\n\nDocstring: No docstring available
\n\n
\n\nFunction: get_spikes
\n\nDocstring: \n Get single-bin spikes only.
\n\nGet x, y pairs recognised as spikes using left and right\nsuccessive differences and standard-deviation-based threshold\nand linear interpolation.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n n_sigma: optional, default is `10`.\n Threshold is `n_sigma` times the standard deviation.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: hdr_from_multi_exposure
\n\nDocstring: Create an HDR spectrum from several spectra with different exposures.
\n\nThe resulting spectrum will have the details in low-intensity peaks\nfrom long-exposure-time spectrum. As long-exposure-time\nspectrum might be sturated, the information for high-intensity\npeaks will be taken from short-exposure-time spectrum.\nThis function will work on a very limited number of spectra,\nbecause we still do not have standardized metadata.\n
\n\n
\n\nFunction: hht_sharpening
\n\nDocstring: \n Hilbert-Huang based sharpening.
\n\nIn order to reduce the overshooting, moving minimum is subtracted from the result\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n movmin: optional. Default is 100\n Window size for moving minimum\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: hht_sharpening_chain
\n\nDocstring: \n Hilbert-Huang based chain sharpening.
\n\nSequence of Hilbert-Huang sharpening procedures are performed.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n movmin: List[int], optional. Default is [150, 50]\n The numer of values in the list defines how many iterations\n of HHT_sharpening will be performed and the values define\n the moving minimum window sizes for the corresponding operations.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: moving_average
\n\nDocstring: \n Moving average filter.
\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n window_size:\n `int`, optional, default is `10`.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: moving_average_convolve
\n\nDocstring: \n Moving average filter.
\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n window_size:\n `int`, optional, default is `10`.\n\nReturns: modified Spectrum\n
\n\n
\n\n\n\nDocstring: \n Moving median filter.
\n\nThe resultant spectrum is moving minimum of the input.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n window_size:\n `int`, optional, default is `10`.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: moving_minimum
\n\nDocstring: \n Moving minimum baseline estimator.\n Successive values are calculated as minima of rolling rectangular window.
\n\n
\n\nFunction: normalize
\n\nDocstring: \n Normalize the spectrum.
\n\nArgs:\n strategy:\n If `unity`: normalize to `sum(y)`. If `min_unity`: subtract the minimum and normalize to 'unity'. If\n `unity_density`: normalize to `\u03a3(y_i*\u0394x_i)`. If `unity_area`: same as `unity_density`. If `minmax`: scale\n amplitudes in range `[0, 1]`. If 'L1' or 'L2': L1 or L2 norm without subtracting the pedestal.\n
\n\n
\n\nFunction: pad_zeros
\n\nDocstring: \n Extend x-axis by 100% in both directions.
\n\nThe x-axis of resultant spectrum will be:\n$[x_{lower}-(x_{upper}-x_{lower})..(x_{upper}+(x_{upper}-x_{lower}))]$.\nThe length of the new spectrum is 3 times the original. The added values\nare with an uniform step. In the middle is the original spectrum with\noriginal x and y values. The coresponding y vallues for the newly added\nx-values are always zeros.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: recover_spikes
\n\nDocstring: \n Recover single-bin spikes.
\n\nRecover x, y pairs recognised as spikes using left and right\nsuccessive differences and standard-deviation-based threshold\nand linear interpolation.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n n_sigma: optional, default is `10`.\n Threshold is `n_sigma` times the standard deviation.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: resample_NUDFT
\n\nDocstring: \n Resample the spectrum using Non-uniform discrete fourier transform.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with NUDFT and inverse FFT.\n\nArgs:\n spe: internal use only\n x_range: optional. Defaults to (0, 4000).\n The x_range of the new spectrum.\n xnew_bins: optional. Defaults to 100.\n Number of bins of the new spectrum\n window: optional, Defaults to None.\n The window to be used for lowpass filter. If None 'blackmanharris' is used.\n If no low-pass filter is required, one can use `window=lambda x: [1]*len(x)`.\n cumulative: optional. Defaults to False.\n If True, the resultant spectrum will be cumulative and normalized\n (in analogy with CDF).\n\nReturns:\n (x_values, y_values)\n
\n\n
\n\nFunction: resample_NUDFT_filter
\n\nDocstring: \n Resample the spectrum using Non-uniform discrete fourier transform.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with NUDFT and inverse FFT.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n x_range: optional. Defaults to (0, 4000).\n The x_range of the new spectrum.\n xnew_bins: optional. Defaults to 100.\n Number of bins of the new spectrum\n window: optional, Defaults to None.\n The window to be used for lowpass filter. If None 'blackmanharris' is used.\n If no low-pass filter is required, one can use `window=lambda x: [1]*len(x)`.\n cumulative: optional. Defaults to False.\n If True, the resultant spectrum will be cumulative and normalized\n (in analogy with CDF).\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: resample_spline
\n\nDocstring: \n Resample the spectrum using spline interpolation.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with spline interpolation.\n\nArgs:\n spe: internal use only\n x_range: optional. Defaults to (0, 4000).\n The x_range of the new spectrum.\n xnew_bins: optional. Defaults to 100.\n Number of bins of the new spectrum\n spline: optional, Defaults to 'pchip'.\n Name of the spline funcion to be used.\n cumulative: optional. Defaults to False.\n If True, the resultant spectrum will be cumulative and normalized\n (in analogy with CDF).\n\nReturns:\n (x_values, y_values)\n
\n\n
\n\nFunction: resample_spline_filter
\n\nDocstring: \n Resample the spectrum using spline interpolation.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with spline interpolation.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n x_range: optional. Defaults to (0, 4000).\n The x_range of the new spectrum.\n xnew_bins: optional. Defaults to 100.\n Number of bins of the new spectrum\n spline: optional, Defaults to 'pchip'.\n Name of the spline funcion to be used.\n cumulative: optional. Defaults to False.\n If True, the resultant spectrum will be cumulative and normalized\n (in analogy with CDF).\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: scale_xaxis_fun
\n\nDocstring: \n Apply arbitrary calibration function to the x-axis values.
\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n fun: function to be applied\n args: Additional arguments to the provided functions\n\nReturns: Corrected spectrum\n\nRaises:\n ValueError: If the new x-values are not strictly monotonically increasing.\n
\n\n
\n\nFunction: scale_xaxis_linear
\n\nDocstring: \n Scale x-axis using a factor.
\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n factor: Defaults to 1.\n Multiply x-axis values with `factor`\n preserve_integral: optional. Defaults to False.\n If True, preserves the integral in sence\n $\\sum y_{orig;\\,i}*{\\Delta x_{orig}}_i = \\sum y_{new;\\,i}*{\\Delta x_{new}}_i = $\nReturns: Corrected spectrum\n
\n\n
\n\nFunction: scale_yaxis_linear
\n\nDocstring: \n Scale y-axis values
\n\nThis function provides the same result as `spe*const`\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n factor optional. Defaults to 1.\n Y-values scaling factor\n\nReturns: corrected spectrum\n
\n\n
\n\nFunction: set_new_xaxis
\n\nDocstring: \n Substitute x-axis values with new ones
\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n xaxis: new x-axis values\n\nReturns: corrected spectrum\n\nRaises:\n ValueError: If the provided array does not match the shape of the spectrum.\n
\n\n
\n\nFunction: shift_cm_1_to_abs_nm
\n\nDocstring: \n Convert Ramanshift in wavenumber to wavelength
\n\nArgs:\n spe: internal use only\n laser_wave_length_nm: Laser wave length\n\nReturns: Corrected x-values\n
\n\n
\n\nFunction: shift_cm_1_to_abs_nm_filter
\n\nDocstring: \n Convert Ramanshift in wavenumber to wavelength
\n\nArgs:\n spe: internal use only\n laser_wave_length_nm: Laser wave length\n\nReturns: Spectrum with corrected x-values\n
\n\n
\n\nFunction: smoothing_RC1
\n\nDocstring: \n Smooth the spectrum.
\n\nThe spectrum will be smoothed using the specified filter.\nThis method is inherited from ramanchada1 for compatibility reasons.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n method: method to be used\n **kwargs: keyword arguments to be passed to the selected method\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: spe_distribution
\n\nDocstring: No docstring available
\n\n
\n\nFunction: spike_indices
\n\nDocstring: \n Find spikes in spectrum
\n\nSingle-bin spikes are located using left and right successive\ndifferences. The threshold is based on the standart deviation\nof the metric which makes this algorithm less optimal.\n\nArgs:\n spe: internal use only\n n_sigma: Threshold value should be `n_sigma` times the standart\n deviation of the metric.\n\nReturns: List of spike indices\n
\n\n
\n\nFunction: subtract_baseline_rc1_als
\n\nDocstring: No docstring available
\n\n
\n\nFunction: subtract_baseline_rc1_snip
\n\nDocstring: No docstring available
\n\n
\n\n\n\nDocstring: \n Subtract moving median filter.
\n\nThe resultant spectrum is moving minimum of the input subtracted from the input.\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n window_size:\n `int`, optional, default is `10`.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: subtract_moving_minimum
\n\nDocstring: No docstring available
\n\n
\n\nFunction: trim_axes
\n\nDocstring: \n Trim axes of the spectrum.
\n\nArgs:\n old_spe: internal use only\n new_spe: internal use only\n method: 'x-axis' or 'bins'\n If 'x-axis' boundaries will be interpreted as x-axis values.\n If 'bins' boundaries will be interpreted as indices.\n boundaries: lower and upper boundary for the trimming.\n\nReturns: modified Spectrum\n
\n\n
\n\nFunction: xcal_argmin2d_iter_lowpass
\n\nDocstring: No docstring available
\n\n
\n\nFunction: xcal_fine
\n\nDocstring: No docstring available
\n\n
\n\nFunction: xcal_fine_RBF
\n\nDocstring: Wavelength calibration using Radial basis fuction interpolation
\n\nPlease be cautious! Interpolation might not be the most appropriate\napproach for this type of calibration.\n\n**kwargs are passed to RBFInterpolator\n
\n\n
\n\nFunction: y_noise_savgol
\n\nDocstring: No docstring available
\n\n
\n\nFunction: y_noise_savgol_DL
\n\nDocstring: No docstring available
\n\n
\n"}, "ramanchada2.auxiliary": {"fullname": "ramanchada2.auxiliary", "modulename": "ramanchada2.auxiliary", "kind": "module", "doc": "\n"}, "ramanchada2.auxiliary.spectra": {"fullname": "ramanchada2.auxiliary.spectra", "modulename": "ramanchada2.auxiliary.spectra", "kind": "module", "doc": "\n"}, "ramanchada2.auxiliary.spectra.datasets2": {"fullname": "ramanchada2.auxiliary.spectra.datasets2", "modulename": "ramanchada2.auxiliary.spectra.datasets2", "kind": "module", "doc": "\n"}, "ramanchada2.auxiliary.spectra.datasets2.data": {"fullname": "ramanchada2.auxiliary.spectra.datasets2.data", "modulename": "ramanchada2.auxiliary.spectra.datasets2", "qualname": "data", "kind": "variable", "doc": "\n", "default_value": "[{'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/NeonSNQ043_iR532_Probe_5msx2.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'Neon'}, {'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/NeonSNQ043_iR532_Probe_100msx2.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'Neon'}, {'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/PST10_iR532_Probe_100_3000msx7.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'PST'}, {'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/S0B10_iR532_Probe_100_60000msx2.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'S0B'}, {'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/S0N10_iR532_Probe_100_30000msx3.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'S0N'}, {'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/S0P10_iR532_Probe_100_60000msx2.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'S0P'}, {'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/S1N10_iR532_Probe_100_22000msx2.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'S1N'}, {'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/Sil10_iR532_Probe_100_60000msx2.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'Sil_'}, {'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/nCAL10_iR532_Probe_100_2500msx3.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'nCAL'}, {'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/sCAL10_iR532_Probe_100_3200msx4.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'sCAL'}, {'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/LED532_Probe_40msx3_1.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'LED532_EL0-9001'}, {'OP': '01', 'device': 'BWtek', 'filename': './FMNT-M_BW532/NIST532_Probe_3000msx8_1.txt', 'laser_wl': '532', 'provider': 'FNMT', 'sample': 'NIST532_SRM2242a'}, {'OP': '01', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/NeonSNQ043_iR785_OP01.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'Neon'}, {'OP': '01', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/PST10_iR785_OP01_40000msx4.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'PST'}, {'OP': '01', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S0B10_iR785_OP01_6000msx4.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S0B'}, {'OP': '01', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S0N10_iR785_OP01_6000msx4.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S0N'}, {'OP': '01', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S0P10_iR785_OP01_6000msx4.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S0P'}, {'OP': '01', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S1N10_iR785_OP01_6000msx4.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S1N'}, {'OP': '01', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/Sil10_iR785_OP01_6000msx4.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'Sil'}, {'OP': '01', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/nCAL10_iR785_OP01_6000msx4.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'nCAL'}, {'OP': '01', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/sCAL10_iR785_OP01_4000msx4.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'sCAL'}, {'OP': '02', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/NeonSNQ043_iR785_OP02.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'Neon'}, {'OP': '02', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/PST10_iR785_OP02_50000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'PST'}, {'OP': '02', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S0B10_iR785_OP02_25000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S0B'}, {'OP': '02', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S0N10_iR785_OP02_25000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S0N'}, {'OP': '02', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S0P10_iR785_OP02_25000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S0P'}, {'OP': '02', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S1N10_iR785_OP02_25000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S1N'}, {'OP': '02', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/Sil10_iR785_OP02_25000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'Sil'}, {'OP': '02', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/nCAL10_iR785_OP02_20000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'nCAL'}, {'OP': '02', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/sCAL10_iR785_OP02_15000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'sCAL'}, {'OP': '03', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/NeonSNQ043_iR785_OP03.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'Neon'}, {'OP': '03', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/PST10_iR785_OP03_8000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'PST'}, {'OP': '03', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S0B10_iR785_OP03_8000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S0B'}, {'OP': '03', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S0N10_iR785_OP03_8000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S0N'}, {'OP': '03', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S0P10_iR785_OP03_8000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S0P'}, {'OP': '03', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/S1N10_iR785_OP03_8000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'S1N'}, {'OP': '03', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/Sil10_iR785_OP03_8000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'Sil'}, {'OP': '03', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/nCAL10_iR785_OP03_8000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'nCAL'}, {'OP': '03', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/sCAL10_iR785_OP03_8000msx2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'sCAL'}, {'OP': '03', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/LED785_Lens_1000x10_2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'NIR785_EL0-9002'}, {'OP': '03', 'device': 'Horiba', 'filename': './FMNT-M_Ho785/NIST785_Lens_80000x5_2.txt', 'laser_wl': '785', 'provider': 'FNMT', 'sample': 'NIST785_SRM2241'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW532/Ne_532nm_x50_800ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'Neon'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW532/Ne_532nm_x50_25ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'Neon'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW532/PST02_iRPlus532_Z050_100_2500msx5.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'PST'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW532/S0B02_iRPlus532_Z050_100_30000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'S0B'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW532/S0N02_iRPlus532_Z050_100_40000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'S0N'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW532/S0P02_iRPlus532_Z050_100_30000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'S0P'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW532/S1N02_iRPlus532_Z050_100_12000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'S1N'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW532/nCAL02_iRPlus532_Z050_100_9000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'nCAL'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW532/sCAL02_iRPlus532_Z050_100_20000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'sCAL'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW532/Ne_532nm_x100_2000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'Neon'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW532/Ne_532nm_x100_110ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'Neon'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW532/PST02_iRPlus532_Z100_100_50000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'PST'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW532/S0B02_iRPlus532_Z100_100_22000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'S0B'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW532/S0N02_iRPlus532_Z100_100_28000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'S0N'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW532/S0P02_iRPlus532_Z100_100_20000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'S0P'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW532/S1N02_iRPlus532_Z100_100_6500ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'S1N'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW532/nCAL02_iRPlus532_Z100_100_30000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'nCAL'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW532/sCAL02_iRPlus532_Z100_100_65000ms.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'sCAL'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW532/Visible_532nm_130ms_100X_2.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'LED532_EL0-9001'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW532/NISTSRM2242aC_BW532_100x_800msx10.txt', 'laser_wl': '532', 'provider': 'ICV', 'sample': 'NIST532_SRM2242a'}, {'OP': '020', 'device': 'BWtek', 'filename': './ICV_BW785/PST02_iRPlus785_Z020_100_1300ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'PST'}, {'OP': '020', 'device': 'BWtek', 'filename': './ICV_BW785/S0B02_iRPlus785_Z020_100_full.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S0B'}, {'OP': '020', 'device': 'BWtek', 'filename': './ICV_BW785/S0B02_iRPlus785_Z020_100_12000ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S0B'}, {'OP': '020', 'device': 'BWtek', 'filename': './ICV_BW785/S0N02_iRPlus785_Z020_100_3800ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S0N'}, {'OP': '020', 'device': 'BWtek', 'filename': './ICV_BW785/S0P02_iRPlus785_Z020_100_12000ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S0P'}, {'OP': '020', 'device': 'BWtek', 'filename': './ICV_BW785/S1N02_iRPlus785_Z020_100_3800ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S1N'}, {'OP': '020', 'device': 'BWtek', 'filename': './ICV_BW785/nCAL02_iRPlus785_Z020_100_1100ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'nCAL'}, {'OP': '020', 'device': 'BWtek', 'filename': './ICV_BW785/sCAL02_iRPlus785_Z020_100_2400ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'sCAL'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW785/PST02_iRPlus785_Z050_100_3200ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'PST'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW785/S0B02_iRPlus785_Z050_100_5500ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S0B'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW785/S0N02_iRPlus785_Z050_100_3200ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S0N'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW785/S0P02_iRPlus785_Z050_100_5700ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S0P'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW785/S1N02_iRPlus785_Z050_100_2100ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S1N'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW785/nCAL02_iRPlus785_Z050_100_2100ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'nCAL'}, {'OP': '050', 'device': 'BWtek', 'filename': './ICV_BW785/sCAL02_iRPlus785_Z050_100_3800ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'sCAL'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW785/PST02_iRPlus785_Z100_100_9000ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'PST'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW785/S0B02_iRPlus785_Z100_100_4700ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S0B'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW785/S0N02_iRPlus785_Z100_100_3100ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S0N'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW785/S0P02_iRPlus785_Z100_100_4800ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S0P'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW785/S1N02_iRPlus785_Z100_100_2000ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'S1N'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW785/nCAL02_iRPlus785_Z100_100_6000ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'nCAL'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW785/sCAL02_iRPlus785_Z100_100_9500ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'sCAL'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW785/NIR_785nm_2000ms_100X_2.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'NIR785_EL0-9002'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW785/NISTSRM2241_BW785_100x_25sx5.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'NIST785_SRM2241'}, {'OP': '100', 'device': 'BWtek', 'filename': './ICV_BW785/Ne_785nm_x20_50ms.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'Neon'}, {'OP': '010', 'device': 'Horiba', 'filename': './TOP_Ho633/neon_new2_Z010.txt', 'laser_wl': '633', 'provider': 'TOP', 'sample': 'Neon'}, {'OP': '010', 'device': 'Horiba', 'filename': './TOP_Ho633/Pol_HLR633_Z010_100_15sx5.txt', 'laser_wl': '633', 'provider': 'TOP', 'sample': 'PST'}, {'OP': '010', 'device': 'Horiba', 'filename': './TOP_Ho633/S0B_HLR633_Z010_100_40sx5.txt', 'laser_wl': '633', 'provider': 'TOP', 'sample': 'S0B'}, {'OP': '010', 'device': 'Horiba', 'filename': './TOP_Ho633/S0N_HLR633_Z010_100_15sx5.txt', 'laser_wl': '633', 'provider': 'TOP', 'sample': 'S0N'}, {'OP': '010', 'device': 'Horiba', 'filename': './TOP_Ho633/S0P_HLR633_Z010_100_40sx5.txt', 'laser_wl': '633', 'provider': 'TOP', 'sample': 'S0P'}, {'OP': '010', 'device': 'Horiba', 'filename': './TOP_Ho633/S1N_HLR633_Z010_100_10sx5.txt', 'laser_wl': '633', 'provider': 'TOP', 'sample': 'S1N'}, {'OP': '010', 'device': 'Horiba', 'filename': './TOP_Ho633/Si_HLR633_Z010_100_40sx5.txt', 'laser_wl': '633', 'provider': 'TOP', 'sample': 'Sil'}, {'OP': '010', 'device': 'Horiba', 'filename': './TOP_Ho633/nCAL_HLR633_Z010_100_5sx5.txt', 'laser_wl': '633', 'provider': 'TOP', 'sample': 'nCAL'}, {'OP': '010', 'device': 'Horiba', 'filename': './TOP_Ho633/sCAL_HLR633_Z010_100_15sx5.txt', 'laser_wl': '633', 'provider': 'TOP', 'sample': 'sCAL'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_100(285mW)_7000msx5ac_1.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '285', 'laser_power_percent': '100', 'time_ms': '7000', 'replicate': '1'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_100(285mW)_7000msx5ac_2.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '285', 'laser_power_percent': '100', 'time_ms': '7000', 'replicate': '2'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_100(285mW)_7000msx5ac_3.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '285', 'laser_power_percent': '100', 'time_ms': '7000', 'replicate': '3'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_100(285mW)_7000msx5ac_4.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '285', 'laser_power_percent': '100', 'time_ms': '7000', 'replicate': '4'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_100(285mW)_7000msx5ac_5.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '285', 'laser_power_percent': '100', 'time_ms': '7000', 'replicate': '5'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_20(42mW)_7000msx5ac_1.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '42', 'laser_power_percent': '20', 'time_ms': '7000', 'replicate': '1'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_20(42mW)_7000msx5ac_2.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '42', 'laser_power_percent': '20', 'time_ms': '7000', 'replicate': '2'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_20(42mW)_7000msx5ac_3.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '42', 'laser_power_percent': '20', 'time_ms': '7000', 'replicate': '3'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_20(42mW)_7000msx5ac_4.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '42', 'laser_power_percent': '20', 'time_ms': '7000', 'replicate': '4'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_20(42mW)_7000msx5ac_5.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '42', 'laser_power_percent': '20', 'time_ms': '7000', 'replicate': '5'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_40(86mW)_7000msx5ac_1.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '86', 'laser_power_percent': '42', 'time_ms': '7000', 'replicate': '1'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_40(86mW)_7000msx5ac_2.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '86', 'laser_power_percent': '42', 'time_ms': '7000', 'replicate': '2'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_40(86mW)_7000msx5ac_3.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '86', 'laser_power_percent': '42', 'time_ms': '7000', 'replicate': '3'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_40(86mW)_7000msx5ac_4.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '86', 'laser_power_percent': '42', 'time_ms': '7000', 'replicate': '4'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_40(86mW)_7000msx5ac_5.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '86', 'laser_power_percent': '42', 'time_ms': '7000', 'replicate': '5'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_60(154mW)_7000msx5ac_1.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '154', 'laser_power_percent': '60', 'time_ms': '7000', 'replicate': '1'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_60(154mW)_7000msx5ac_2.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '154', 'laser_power_percent': '60', 'time_ms': '7000', 'replicate': '2'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_60(154mW)_7000msx5ac_3.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '154', 'laser_power_percent': '60', 'time_ms': '7000', 'replicate': '3'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_60(154mW)_7000msx5ac_4.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '154', 'laser_power_percent': '60', 'time_ms': '7000', 'replicate': '4'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_60(154mW)_7000msx5ac_5.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '154', 'laser_power_percent': '60', 'time_ms': '7000', 'replicate': '5'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_80(223mW)_7000msx5ac_1.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '232', 'laser_power_percent': '80', 'time_ms': '7000', 'replicate': '1'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_80(223mW)_7000msx5ac_2.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '232', 'laser_power_percent': '80', 'time_ms': '7000', 'replicate': '2'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_80(223mW)_7000msx5ac_3.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '232', 'laser_power_percent': '80', 'time_ms': '7000', 'replicate': '3'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_80(223mW)_7000msx5ac_4.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '232', 'laser_power_percent': '80', 'time_ms': '7000', 'replicate': '4'}, {'OP': '20x', 'device': 'BWtek', 'filename': './ICV_BW785/twinning/0_5A_P_iRaman785_20X_80(223mW)_7000msx5ac_5.txt', 'laser_wl': '785', 'provider': 'ICV', 'sample': 'TiO2', 'laser_power_mW': '232', 'laser_power_percent': '80', 'time_ms': '7000', 'replicate': '5'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_100(292mW)_6000msx5ac_1.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '292', 'laser_power_percent': '100', 'time_ms': '6000', 'replicate': '1'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_100(292mW)_6000msx5ac_2.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '292', 'laser_power_percent': '100', 'time_ms': '6000', 'replicate': '2'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_100(292mW)_6000msx5ac_3.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '292', 'laser_power_percent': '100', 'time_ms': '6000', 'replicate': '3'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_100(292mW)_6000msx5ac_4.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '292', 'laser_power_percent': '100', 'time_ms': '6000', 'replicate': '4'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_100(292mW)_6000msx5ac_5.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '292', 'laser_power_percent': '100', 'time_ms': '6000', 'replicate': '5'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_20(46mW)_6000msx5ac_1.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '46', 'laser_power_percent': '20', 'time_ms': '6000', 'replicate': '1'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_20(46mW)_6000msx5ac_2.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '46', 'laser_power_percent': '20', 'time_ms': '6000', 'replicate': '2'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_20(46mW)_6000msx5ac_3.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '46', 'laser_power_percent': '20', 'time_ms': '6000', 'replicate': '3'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_20(46mW)_6000msx5ac_4.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '46', 'laser_power_percent': '20', 'time_ms': '6000', 'replicate': '4'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_20(46mW)_6000msx5ac_5.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '46', 'laser_power_percent': '20', 'time_ms': '6000', 'replicate': '5'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_40(106mW)_6000msx5ac_1.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '106', 'laser_power_percent': '40', 'time_ms': '6000', 'replicate': '1'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_40(106mW)_6000msx5ac_2.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '106', 'laser_power_percent': '40', 'time_ms': '6000', 'replicate': '2'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_40(106mW)_6000msx5ac_3.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '106', 'laser_power_percent': '40', 'time_ms': '6000', 'replicate': '3'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_40(106mW)_6000msx5ac_4.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '106', 'laser_power_percent': '40', 'time_ms': '6000', 'replicate': '4'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_40(106mW)_6000msx5ac_5.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '106', 'laser_power_percent': '40', 'time_ms': '6000', 'replicate': '5'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_60(166mW)_6000msx5ac_1.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '166', 'laser_power_percent': '60', 'time_ms': '6000', 'replicate': '1'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_60(166mW)_6000msx5ac_2.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '166', 'laser_power_percent': '60', 'time_ms': '6000', 'replicate': '2'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_60(166mW)_6000msx5ac_3.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '166', 'laser_power_percent': '60', 'time_ms': '6000', 'replicate': '3'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_60(166mW)_6000msx5ac_4.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '166', 'laser_power_percent': '60', 'time_ms': '6000', 'replicate': '4'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_60(166mW)_6000msx5ac_5.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '166', 'laser_power_percent': '60', 'time_ms': '6000', 'replicate': '5'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_80(227mW)_6000msx5ac_1.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '227', 'laser_power_percent': '80', 'time_ms': '6000', 'replicate': '1'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_80(227mW)_6000msx5ac_2.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '227', 'laser_power_percent': '80', 'time_ms': '6000', 'replicate': '2'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_80(227mW)_6000msx5ac_3.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '227', 'laser_power_percent': '80', 'time_ms': '6000', 'replicate': '3'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_80(227mW)_6000msx5ac_4.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '227', 'laser_power_percent': '80', 'time_ms': '6000', 'replicate': '4'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/twinning/0_5A_P_iRaman785_Probe_80(227mW)_6000msx5ac_5.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'TiO2', 'laser_power_mW': '227', 'laser_power_percent': '80', 'time_ms': '6000', 'replicate': '5'}, {'OP': '20x', 'device': 'BWtek', 'filename': './FNMT-B_BW785/NIST_785nm_100%_2500msx3_1.txt', 'laser_wl': '785', 'provider': 'FNMT-B', 'sample': 'Neon'}]"}, "ramanchada2.auxiliary.spectra.datasets2.df": {"fullname": "ramanchada2.auxiliary.spectra.datasets2.df", "modulename": "ramanchada2.auxiliary.spectra.datasets2", "qualname": "df", "kind": "variable", "doc": "\n", "default_value": " OP device ... time_ms replicate\n0 01 BWtek ... NaN NaN\n1 01 BWtek ... NaN NaN\n2 01 BWtek ... NaN NaN\n3 01 BWtek ... NaN NaN\n4 01 BWtek ... NaN NaN\n.. ... ... ... ... ...\n141 20x BWtek ... 6000 2\n142 20x BWtek ... 6000 3\n143 20x BWtek ... 6000 4\n144 20x BWtek ... 6000 5\n145 20x BWtek ... NaN NaN\n\n[146 rows x 10 columns]"}, "ramanchada2.auxiliary.spectra.datasets2.loc": {"fullname": "ramanchada2.auxiliary.spectra.datasets2.loc", "modulename": "ramanchada2.auxiliary.spectra.datasets2", "qualname": "loc", "kind": "variable", "doc": "\n", "default_value": "PosixPath('/home/runner/work/ramanchada2/ramanchada2/.tox/docs/lib/python3.11/site-packages/ramanchada2/auxiliary/spectra/datasets2')"}, "ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"fullname": "ramanchada2.auxiliary.spectra.datasets2.filtered_df", "modulename": "ramanchada2.auxiliary.spectra.datasets2", "qualname": "filtered_df", "kind": "function", "doc": "\n", "signature": "(**kwargs):", "funcdef": "def"}, "ramanchada2.auxiliary.spectra.datasets2.get_filters": {"fullname": "ramanchada2.auxiliary.spectra.datasets2.get_filters", "modulename": "ramanchada2.auxiliary.spectra.datasets2", "qualname": "get_filters", "kind": "function", "doc": "\n", "signature": "(**kwargs):", "funcdef": "def"}, "ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"fullname": "ramanchada2.auxiliary.spectra.datasets2.get_filenames", "modulename": "ramanchada2.auxiliary.spectra.datasets2", "qualname": "get_filenames", "kind": "function", "doc": "\n", "signature": "(**kwargs):", "funcdef": "def"}, "ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"fullname": "ramanchada2.auxiliary.spectra.datasets2.prepend_prefix", "modulename": "ramanchada2.auxiliary.spectra.datasets2", "qualname": "prepend_prefix", "kind": "function", "doc": "\n", "signature": "(filenames):", "funcdef": "def"}, "ramanchada2.auxiliary.spectra.simulated": {"fullname": "ramanchada2.auxiliary.spectra.simulated", "modulename": "ramanchada2.auxiliary.spectra.simulated", "kind": "module", "doc": "\n"}, "ramanchada2.auxiliary.spectra.simulated.loc": {"fullname": "ramanchada2.auxiliary.spectra.simulated.loc", "modulename": "ramanchada2.auxiliary.spectra.simulated", "qualname": "loc", "kind": "variable", "doc": "\n", "default_value": "PosixPath('/home/runner/work/ramanchada2/ramanchada2/.tox/docs/lib/python3.11/site-packages/ramanchada2/auxiliary/spectra/simulated')"}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"fullname": "ramanchada2.auxiliary.spectra.simulated.FILES", "modulename": "ramanchada2.auxiliary.spectra.simulated", "qualname": "FILES", "kind": "variable", "doc": "\n", "default_value": "{'calcite_crystal_raw': '/home/runner/work/ramanchada2/ramanchada2/.tox/docs/lib/python3.11/site-packages/ramanchada2/auxiliary/spectra/simulated/crystal/calcite_CRYSTAL_PBE_raw_data.dat', 'calcite_crystal_convolved': '/home/runner/work/ramanchada2/ramanchada2/.tox/docs/lib/python3.11/site-packages/ramanchada2/auxiliary/spectra/simulated/crystal/calcite_CRYSTAL_PBE_convoluted.dat', 'calcite_vasp': '/home/runner/work/ramanchada2/ramanchada2/.tox/docs/lib/python3.11/site-packages/ramanchada2/auxiliary/spectra/simulated/vasp/snCAL_vasp_raman_ALL.dat'}"}, "ramanchada2.io": {"fullname": "ramanchada2.io", "modulename": "ramanchada2.io", "kind": "module", "doc": "\n"}, "ramanchada2.io.HSDS": {"fullname": "ramanchada2.io.HSDS", "modulename": "ramanchada2.io.HSDS", "kind": "module", "doc": "\n"}, "ramanchada2.io.HSDS.logger": {"fullname": "ramanchada2.io.HSDS.logger", "modulename": "ramanchada2.io.HSDS", "qualname": "logger", "kind": "variable", "doc": "\n", "default_value": "<RootLogger root (WARNING)>"}, "ramanchada2.io.HSDS.write_nexus": {"fullname": "ramanchada2.io.HSDS.write_nexus", "modulename": "ramanchada2.io.HSDS", "qualname": "write_nexus", "kind": "function", "doc": "\n", "signature": "(\tfilename: str,\tdataset: str,\tx: numpy.ndarray[typing.Any, numpy.dtype[+_ScalarType_co]],\ty: numpy.ndarray[typing.Any, numpy.dtype[+_ScalarType_co]],\tmeta: Dict,\th5module=None):", "funcdef": "def"}, "ramanchada2.io.HSDS.DatasetExistsError": {"fullname": "ramanchada2.io.HSDS.DatasetExistsError", "modulename": "ramanchada2.io.HSDS", "qualname": "DatasetExistsError", "kind": "class", "doc": "Common base class for all non-exit exceptions.
\n", "bases": "builtins.Exception"}, "ramanchada2.io.HSDS.sanitize_key": {"fullname": "ramanchada2.io.HSDS.sanitize_key", "modulename": "ramanchada2.io.HSDS", "qualname": "sanitize_key", "kind": "function", "doc": "\n", "signature": "(key: str) -> str:", "funcdef": "def"}, "ramanchada2.io.HSDS.write_cha": {"fullname": "ramanchada2.io.HSDS.write_cha", "modulename": "ramanchada2.io.HSDS", "qualname": "write_cha", "kind": "function", "doc": "\n", "signature": "(\tfilename: str,\tdataset: str,\tx: numpy.ndarray[typing.Any, numpy.dtype[+_ScalarType_co]],\ty: numpy.ndarray[typing.Any, numpy.dtype[+_ScalarType_co]],\tmeta: Dict,\th5module=None):", "funcdef": "def"}, "ramanchada2.io.HSDS.read_cha": {"fullname": "ramanchada2.io.HSDS.read_cha", "modulename": "ramanchada2.io.HSDS", "qualname": "read_cha", "kind": "function", "doc": "\n", "signature": "(\tfilename: str,\tdataset: str,\th5module=None) -> Tuple[numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], Dict]:", "funcdef": "def"}, "ramanchada2.io.HSDS.filter_dataset": {"fullname": "ramanchada2.io.HSDS.filter_dataset", "modulename": "ramanchada2.io.HSDS", "qualname": "filter_dataset", "kind": "function", "doc": "\n", "signature": "(\ttopdomain,\tdomain,\tprocess_file,\tsample=None,\twavelength=None,\tinstrument=None,\tprovider=None,\tinvestigation=None,\tkwargs={},\th5module=None):", "funcdef": "def"}, "ramanchada2.io.HSDS.visit_domain": {"fullname": "ramanchada2.io.HSDS.visit_domain", "modulename": "ramanchada2.io.HSDS", "qualname": "visit_domain", "kind": "function", "doc": "\n", "signature": "(topdomain='/', process_dataset=None, kwargs={}, h5module=None):", "funcdef": "def"}, "ramanchada2.io.experimental": {"fullname": "ramanchada2.io.experimental", "modulename": "ramanchada2.io.experimental", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.bw_format": {"fullname": "ramanchada2.io.experimental.bw_format", "modulename": "ramanchada2.io.experimental.bw_format", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.bw_format.bw_format": {"fullname": "ramanchada2.io.experimental.bw_format.bw_format", "modulename": "ramanchada2.io.experimental.bw_format", "qualname": "bw_format", "kind": "function", "doc": "\n", "signature": "(lines: List[str]) -> Tuple[pandas.core.frame.DataFrame, Dict]:", "funcdef": "def"}, "ramanchada2.io.experimental.neegala_format": {"fullname": "ramanchada2.io.experimental.neegala_format", "modulename": "ramanchada2.io.experimental.neegala_format", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"fullname": "ramanchada2.io.experimental.neegala_format.neegala_format", "modulename": "ramanchada2.io.experimental.neegala_format", "qualname": "neegala_format", "kind": "function", "doc": "\n", "signature": "(lines: List[str]) -> Tuple[pandas.core.frame.DataFrame, Dict]:", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser": {"fullname": "ramanchada2.io.experimental.rc1_parser", "modulename": "ramanchada2.io.experimental.rc1_parser", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.rc1_parser.binary_readers": {"fullname": "ramanchada2.io.experimental.rc1_parser.binary_readers", "modulename": "ramanchada2.io.experimental.rc1_parser.binary_readers", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"fullname": "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA", "modulename": "ramanchada2.io.experimental.rc1_parser.binary_readers", "qualname": "readSPA", "kind": "function", "doc": "function to read k-vector and spectrum from a *.SPA file
\n\nArguments:
\n\n\n- filename: Full path to the file to be read.
\n
\n\nReturns:
\n\n\n k-vector and spectrum as separate arrays: (np.array, np.array)
.
\n
\n", "signature": "(filename: str, flip=True):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"fullname": "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs", "modulename": "ramanchada2.io.experimental.rc1_parser.binary_readers", "qualname": "read_ngs", "kind": "function", "doc": "\n", "signature": "(file):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"fullname": "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock", "modulename": "ramanchada2.io.experimental.rc1_parser.binary_readers", "qualname": "read_4byte_datablock", "kind": "function", "doc": "\n", "signature": "(f, length, skip=8):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"fullname": "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring", "modulename": "ramanchada2.io.experimental.rc1_parser.binary_readers", "qualname": "read_bytestring", "kind": "function", "doc": "\n", "signature": "(f):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"fullname": "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta", "modulename": "ramanchada2.io.experimental.rc1_parser.binary_readers", "qualname": "read_ngs_meta", "kind": "function", "doc": "\n", "signature": "(f):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.io": {"fullname": "ramanchada2.io.experimental.rc1_parser.io", "modulename": "ramanchada2.io.experimental.rc1_parser.io", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"fullname": "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError", "modulename": "ramanchada2.io.experimental.rc1_parser.io", "qualname": "UnsupportedFileTypeError", "kind": "class", "doc": "Common base class for all non-exit exceptions.
\n", "bases": "builtins.Exception"}, "ramanchada2.io.experimental.rc1_parser.io.parse": {"fullname": "ramanchada2.io.experimental.rc1_parser.io.parse", "modulename": "ramanchada2.io.experimental.rc1_parser.io", "qualname": "parse", "kind": "function", "doc": "\n", "signature": "(source_path, file_type=None):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"fullname": "ramanchada2.io.experimental.rc1_parser.io.cleanMeta", "modulename": "ramanchada2.io.experimental.rc1_parser.io", "qualname": "cleanMeta", "kind": "function", "doc": "\n", "signature": "(meta):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.third_party_readers": {"fullname": "ramanchada2.io.experimental.rc1_parser.third_party_readers", "modulename": "ramanchada2.io.experimental.rc1_parser.third_party_readers", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"fullname": "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF", "modulename": "ramanchada2.io.experimental.rc1_parser.third_party_readers", "qualname": "readWDF", "kind": "function", "doc": "\n", "signature": "(file):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"fullname": "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC", "modulename": "ramanchada2.io.experimental.rc1_parser.third_party_readers", "qualname": "readSPC", "kind": "function", "doc": "\n", "signature": "(file):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"fullname": "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS", "modulename": "ramanchada2.io.experimental.rc1_parser.third_party_readers", "qualname": "readOPUS", "kind": "function", "doc": "\n", "signature": "(file, obj_no=0):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers": {"fullname": "ramanchada2.io.experimental.rc1_parser.txt_format_readers", "modulename": "ramanchada2.io.experimental.rc1_parser.txt_format_readers", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"fullname": "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger", "modulename": "ramanchada2.io.experimental.rc1_parser.txt_format_readers", "qualname": "logger", "kind": "variable", "doc": "\n", "default_value": "<Logger ramanchada2.io.experimental.rc1_parser.txt_format_readers (WARNING)>"}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"fullname": "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP", "modulename": "ramanchada2.io.experimental.rc1_parser.txt_format_readers", "qualname": "read_JCAMP", "kind": "function", "doc": "\n", "signature": "(file, verbose=True):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"fullname": "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT", "modulename": "ramanchada2.io.experimental.rc1_parser.txt_format_readers", "qualname": "readTXT", "kind": "function", "doc": "\n", "signature": "(file, x_col=0, y_col=0, verbose=True):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"fullname": "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines", "modulename": "ramanchada2.io.experimental.rc1_parser.txt_format_readers", "qualname": "dataFromTxtLines", "kind": "function", "doc": "\n", "signature": "(data_lines):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"fullname": "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine", "modulename": "ramanchada2.io.experimental.rc1_parser.txt_format_readers", "qualname": "isDataLine", "kind": "function", "doc": "\n", "signature": "(line):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"fullname": "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop", "modulename": "ramanchada2.io.experimental.rc1_parser.txt_format_readers", "qualname": "startStop", "kind": "function", "doc": "\n", "signature": "(lines):", "funcdef": "def"}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"fullname": "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType", "modulename": "ramanchada2.io.experimental.rc1_parser.txt_format_readers", "qualname": "getYDataType", "kind": "function", "doc": "\n", "signature": "(y_data):", "funcdef": "def"}, "ramanchada2.io.experimental.read_csv": {"fullname": "ramanchada2.io.experimental.read_csv", "modulename": "ramanchada2.io.experimental.read_csv", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.read_csv.read_csv": {"fullname": "ramanchada2.io.experimental.read_csv.read_csv", "modulename": "ramanchada2.io.experimental.read_csv", "qualname": "read_csv", "kind": "function", "doc": "\n", "signature": "(\tdata_in: <class 'TextIO'>) -> Tuple[numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], Dict]:", "funcdef": "def"}, "ramanchada2.io.experimental.read_spe": {"fullname": "ramanchada2.io.experimental.read_spe", "modulename": "ramanchada2.io.experimental.read_spe", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.read_spe.read_spe": {"fullname": "ramanchada2.io.experimental.read_spe.read_spe", "modulename": "ramanchada2.io.experimental.read_spe", "qualname": "read_spe", "kind": "function", "doc": "Princeton Instruments spe format
\n", "signature": "(filename):", "funcdef": "def"}, "ramanchada2.io.experimental.read_txt": {"fullname": "ramanchada2.io.experimental.read_txt", "modulename": "ramanchada2.io.experimental.read_txt", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.read_txt.read_txt": {"fullname": "ramanchada2.io.experimental.read_txt.read_txt", "modulename": "ramanchada2.io.experimental.read_txt", "qualname": "read_txt", "kind": "function", "doc": "\n", "signature": "(\tdata_in: <class 'TextIO'>) -> Tuple[numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], Dict]:", "funcdef": "def"}, "ramanchada2.io.experimental.rruf_format": {"fullname": "ramanchada2.io.experimental.rruf_format", "modulename": "ramanchada2.io.experimental.rruf_format", "kind": "module", "doc": "\n"}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"fullname": "ramanchada2.io.experimental.rruf_format.rruf_format", "modulename": "ramanchada2.io.experimental.rruf_format", "qualname": "rruf_format", "kind": "function", "doc": "\n", "signature": "(\tlines: List[str]) -> Tuple[numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], Dict]:", "funcdef": "def"}, "ramanchada2.io.output": {"fullname": "ramanchada2.io.output", "modulename": "ramanchada2.io.output", "kind": "module", "doc": "\n"}, "ramanchada2.io.output.write_csv": {"fullname": "ramanchada2.io.output.write_csv", "modulename": "ramanchada2.io.output.write_csv", "kind": "module", "doc": "\n"}, "ramanchada2.io.output.write_csv.write_csv": {"fullname": "ramanchada2.io.output.write_csv.write_csv", "modulename": "ramanchada2.io.output.write_csv", "qualname": "write_csv", "kind": "function", "doc": "\n", "signature": "(x, y, delimiter=',') -> List[str]:", "funcdef": "def"}, "ramanchada2.io.simulated": {"fullname": "ramanchada2.io.simulated", "modulename": "ramanchada2.io.simulated", "kind": "module", "doc": "\n"}, "ramanchada2.io.simulated.crystal": {"fullname": "ramanchada2.io.simulated.crystal", "modulename": "ramanchada2.io.simulated.crystal", "kind": "module", "doc": "\n"}, "ramanchada2.io.simulated.crystal.discrete_lines_dat": {"fullname": "ramanchada2.io.simulated.crystal.discrete_lines_dat", "modulename": "ramanchada2.io.simulated.crystal.discrete_lines_dat", "kind": "module", "doc": "\n"}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"fullname": "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat", "modulename": "ramanchada2.io.simulated.crystal.discrete_lines_dat", "qualname": "lines_from_crystal_dat", "kind": "function", "doc": "\n", "signature": "(data_in: io.TextIOBase) -> pandas.core.frame.DataFrame:", "funcdef": "def"}, "ramanchada2.io.simulated.crystal.discrete_lines_out": {"fullname": "ramanchada2.io.simulated.crystal.discrete_lines_out", "modulename": "ramanchada2.io.simulated.crystal.discrete_lines_out", "kind": "module", "doc": "\n"}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"fullname": "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out", "modulename": "ramanchada2.io.simulated.crystal.discrete_lines_out", "qualname": "lines_from_crystal_out", "kind": "function", "doc": "\n", "signature": "(data_in: io.TextIOBase) -> pandas.core.frame.DataFrame:", "funcdef": "def"}, "ramanchada2.io.simulated.lines_from_raw_dat": {"fullname": "ramanchada2.io.simulated.lines_from_raw_dat", "modulename": "ramanchada2.io.simulated.lines_from_raw_dat", "kind": "module", "doc": "\n"}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"fullname": "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat", "modulename": "ramanchada2.io.simulated.lines_from_raw_dat", "qualname": "lines_from_raw_dat", "kind": "function", "doc": "\n", "signature": "(data_in: io.TextIOBase) -> pandas.core.frame.DataFrame:", "funcdef": "def"}, "ramanchada2.io.simulated.read_simulated_lines": {"fullname": "ramanchada2.io.simulated.read_simulated_lines", "modulename": "ramanchada2.io.simulated.read_simulated_lines", "kind": "module", "doc": "\n"}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"fullname": "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines", "modulename": "ramanchada2.io.simulated.read_simulated_lines", "qualname": "read_simulated_lines", "kind": "function", "doc": "\n", "signature": "(\tdata_in: io.TextIOBase,\tsim_type: Literal['vasp', 'crystal_out', 'crystal_dat', 'raw_dat'],\tuse: Set[Literal['I_tot', 'I_perp', 'I_par', 'I_xx', 'I_xy', 'I_xz', 'I_yy', 'I_yz', 'I_zz']] = {'I_tot'}) -> Tuple[List[str], List[float], Dict[str, List[float]]]:", "funcdef": "def"}, "ramanchada2.io.simulated.vasp": {"fullname": "ramanchada2.io.simulated.vasp", "modulename": "ramanchada2.io.simulated.vasp", "kind": "module", "doc": "\n"}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat": {"fullname": "ramanchada2.io.simulated.vasp.vasp_simulation_dat", "modulename": "ramanchada2.io.simulated.vasp.vasp_simulation_dat", "kind": "module", "doc": "\n"}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"fullname": "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat", "modulename": "ramanchada2.io.simulated.vasp.vasp_simulation_dat", "qualname": "lines_from_vasp_dat", "kind": "function", "doc": "calculates perpendicular and parallel intensities using\nhttps://doi.org/10.1103/PhysRevB.54.7830
\n", "signature": "(data_in: io.TextIOBase) -> pandas.core.frame.DataFrame:", "funcdef": "def"}, "ramanchada2.misc": {"fullname": "ramanchada2.misc", "modulename": "ramanchada2.misc", "kind": "module", "doc": "\n"}, "ramanchada2.misc.base_class": {"fullname": "ramanchada2.misc.base_class", "modulename": "ramanchada2.misc.base_class", "kind": "module", "doc": "\n"}, "ramanchada2.misc.base_class.BaseClass": {"fullname": "ramanchada2.misc.base_class.BaseClass", "modulename": "ramanchada2.misc.base_class", "qualname": "BaseClass", "kind": "class", "doc": "\n"}, "ramanchada2.misc.base_class.BaseClass.origin": {"fullname": "ramanchada2.misc.base_class.BaseClass.origin", "modulename": "ramanchada2.misc.base_class", "qualname": "BaseClass.origin", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.base_class.BaseClass.origin_list_str": {"fullname": "ramanchada2.misc.base_class.BaseClass.origin_list_str", "modulename": "ramanchada2.misc.base_class", "qualname": "BaseClass.origin_list_str", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.constants": {"fullname": "ramanchada2.misc.constants", "modulename": "ramanchada2.misc.constants", "kind": "module", "doc": "\n"}, "ramanchada2.misc.constants.PST_RS_dict": {"fullname": "ramanchada2.misc.constants.PST_RS_dict", "modulename": "ramanchada2.misc.constants", "qualname": "PST_RS_dict", "kind": "variable", "doc": "\n", "default_value": "{620.9: 16, 795.8: 10, 1001.4: 100, 1031.8: 27, 1155.3: 13, 1450.5: 8, 1583.1: 12, 1602.3: 28, 2852.4: 9, 2904.5: 13, 3054.3: 32}"}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"fullname": "ramanchada2.misc.constants.neon_nist_wl_nm", "modulename": "ramanchada2.misc.constants", "qualname": "neon_nist_wl_nm", "kind": "variable", "doc": "\n", "default_value": "{200.7009: 80, 202.55599999999998: 80, 208.54659999999998: 150, 209.61060000000003: 200, 209.6248: 120, 256.2123: 80, 256.7121: 90, 262.3107: 80, 262.98850000000004: 80, 263.6069: 90, 263.82890000000003: 80, 264.40970000000004: 80, 276.2921: 80, 279.20189999999997: 90, 279.4221: 80, 280.9485: 100, 290.6592: 80, 290.6816: 80, 291.0061: 90, 291.0408: 90, 291.11379999999997: 80, 291.5122: 80, 292.5618: 80, 293.2103: 80, 294.0653: 80, 294.6044: 90, 295.5725: 150, 296.3236: 150, 296.71840000000003: 150, 297.2997: 100, 297.47189: 30, 297.9461: 100, 298.26696000000004: 30, 300.1668: 150, 301.7311: 120, 302.7016: 300, 302.8864: 300, 303.07869999999997: 100, 303.4461: 120, 303.59229999999997: 100, 303.772: 100, 303.9586: 100, 304.40880000000004: 100, 304.5556: 100, 304.7556: 120, 305.43449999999996: 100, 305.46770000000004: 100, 305.73906999999997: 30, 305.91060000000004: 100, 306.2491: 100, 306.3301: 100, 307.0887: 100, 307.1529: 100, 307.5731: 100, 308.8166: 120, 309.2092: 100, 309.2901: 120, 309.4006: 100, 309.51030000000003: 100, 309.7131: 100, 311.798: 100, 311.816: 120, 314.1332: 300, 314.3721: 100, 314.8681: 100, 316.4429: 100, 316.5648: 100, 318.8743: 100, 319.4579: 120, 319.85859999999997: 500, 320.8965: 60, 320.9356: 120, 321.37350000000004: 120, 321.4329: 150, 321.8193: 150, 322.4818: 120, 322.9573: 120, 323.007: 200, 323.0419: 120, 323.2022: 120, 323.2372: 150, 324.3396: 100, 324.4095: 100, 324.8345: 100, 325.0355: 100, 329.7726: 150, 330.974: 150, 331.97220000000004: 300, 332.3745: 1000, 332.71529999999996: 150, 332.9158: 100, 333.48359999999997: 200, 334.4395: 150, 334.5453: 300, 334.5829: 150, 335.5016: 200, 335.78200000000004: 120, 336.0597: 200, 336.2161: 120, 336.2707: 100, 336.7218: 120, 336.98076000000003: 50, 336.99072: 70, 337.1799: 100, 337.8216: 500, 338.8417: 150, 338.8945: 120, 339.27979999999997: 300, 340.48220000000003: 100, 340.6947: 120, 341.3148: 100, 341.69140000000004: 120, 341.7688: 120, 341.79031: 50, 341.80055000000004: 5, 342.8687: 120, 344.77024: 20, 345.41944: 10, 345.661: 100, 345.9321: 100, 346.05237: 10, 346.43382: 10, 346.65781000000004: 20, 347.25706: 50, 347.95189999999997: 150, 348.0718: 200, 348.1933: 200, 349.80636: 10, 350.12159: 20, 351.51902: 20, 352.04711000000003: 100, 354.28470000000004: 120, 355.78049999999996: 120, 356.1198: 100, 356.8502: 250, 357.4181: 100, 357.4612: 200, 359.35257: 50, 359.36388999999997: 30, 360.01685000000003: 10, 363.3664: 10, 364.3927: 150, 366.40729999999996: 200, 368.22420999999997: 10, 368.57352000000003: 10, 369.42130000000003: 200, 370.12244: 4, 370.9622: 150, 371.3079: 250, 372.7107: 250, 376.6259: 800, 377.7133: 1000, 381.84270000000004: 100, 382.9749: 120, 421.9745: 150, 423.38500000000005: 100, 425.0649: 120, 436.9862: 120, 437.93999999999994: 70, 437.95500000000004: 150, 438.5059: 100, 439.1991: 200, 439.799: 150, 440.9299: 150, 441.3215: 100, 442.13890000000004: 100, 442.85159999999996: 100, 442.8634: 100, 443.09040000000005: 150, 443.0942: 150, 445.7049: 120, 452.27200000000005: 100, 453.77545: 100, 456.90569999999997: 100, 470.43949000000003: 150, 470.88594: 120, 471.00649999999996: 100, 471.20633: 150, 471.5344: 150, 475.2732: 50, 478.89258: 100, 479.02195: 50, 482.7338: 100, 488.49170000000004: 100, 500.51587: 50, 503.77511999999996: 50, 514.49384: 50, 533.07775: 60, 534.10938: 100, 534.32834: 60, 540.05618: 200, 556.27662: 50, 565.66588: 50, 571.92248: 50, 574.82985: 50, 576.4418800000001: 70, 580.44496: 50, 582.01558: 50, 585.24879: 200, 587.2827500000001: 50, 588.18952: 100, 590.24623: 5, 590.64294: 5, 594.48342: 50, 596.5471: 50, 597.46273: 50, 597.5534: 60, 598.79074: 15, 602.99969: 100, 607.43377: 100, 609.61631: 30, 612.8449899999999: 10, 614.3062600000001: 100, 616.35939: 100, 618.2146: 15, 621.72812: 100, 626.6495: 100, 630.47889: 10, 632.81646: 30, 633.4427800000001: 100, 638.29917: 100, 640.2248: 200, 650.65281: 150, 653.28822: 10, 659.89529: 100, 665.2092700000001: 15, 667.82762: 50, 671.7043: 7, 692.94673: 1000, 702.40504: 300, 703.24131: 800, 705.12923: 20, 705.91074: 100, 717.39381: 800, 721.3199999999999: 150, 723.5188: 150, 724.51666: 800, 734.3945: 150, 747.24386: 30, 748.88712: 300, 749.2102: 100, 752.2818: 150, 753.57741: 300, 754.4044299999999: 130, 772.4623300000001: 1, 774.0738: 120, 783.9052899999999: 2, 792.6201: 120, 792.71177: 3, 793.69961: 13, 794.3181400000001: 80, 808.2457999999999: 60, 808.4345000000001: 100, 811.85492: 40, 812.89108: 12, 813.64054: 170, 825.9379000000001: 30, 826.4807000000001: 100, 826.60772: 70, 826.71162: 10, 830.03258: 300, 831.4995000000001: 100, 836.57466: 50, 837.2106: 100, 837.7608: 800, 841.71606: 30, 841.84274: 250, 846.33575: 40, 848.44435: 13, 849.53598: 700, 854.46958: 15, 857.13524: 30, 859.12584: 400, 863.4647000000001: 350, 864.70411: 60, 865.4383099999999: 600, 865.5522000000001: 80, 866.8255999999999: 100, 867.94925: 130, 868.19211: 150, 870.41116: 30, 877.1656300000001: 100, 878.06226: 600, 878.3753300000001: 400, 883.0907199999999: 6, 885.38668: 300, 886.53063: 20, 886.57552: 150, 891.9500599999999: 60, 898.85564: 20, 907.9462: 100, 914.86716: 120, 920.1759099999999: 90, 922.0060100000001: 60, 922.1580099999999: 20, 922.66903: 20, 927.55196: 9, 928.7563: 200, 930.0852699999999: 80, 931.0583899999999: 8, 931.39726: 30, 932.65068: 70, 937.33078: 15, 942.5378800000001: 50, 945.9209500000001: 30, 948.66818: 50, 953.4162899999999: 60, 954.7404899999999: 30, 957.7013000000001: 120, 966.54197: 180, 980.8860000000001: 100, 1029.5417400000001: 4, 1056.24075: 80, 1079.80429: 60, 1084.44772: 90, 1114.3020000000001: 300, 1117.7523999999999: 500, 1139.04339: 150, 1140.91343: 90, 1152.27459: 300, 1152.5019399999999: 150, 1153.63445: 90, 1160.15366: 30, 1161.40807: 130, 1168.80017: 30, 1176.67924: 150, 1178.90435: 130, 1178.98891: 30, 1198.4912: 70, 1206.6334000000002: 200, 1245.9388999999999: 40, 1268.9200999999998: 60, 1291.2014: 80, 1321.9241: 40, 1523.0714: 50, 1716.1929: 20, 1803.5812: 20, 1808.3181: 40, 1808.3263: 9, 1822.1087: 15, 1822.7015999999999: 13, 1827.6642: 140, 1828.2614: 100, 1830.3967: 70, 1835.9094: 20, 1838.4826: 60, 1838.9937000000002: 90, 1840.2836: 40, 1842.2401999999997: 60, 1845.864: 13, 1847.58: 40, 1859.1541000000002: 70, 1859.7698: 100, 1861.8908: 16, 1862.5158999999999: 20, 2104.127: 30, 2170.811: 30, 2224.736: 13, 2242.814: 13, 2253.038: 80, 2266.179: 13, 2310.048: 25, 2326.027: 40, 2337.296: 50, 2356.5330000000004: 30, 2363.648: 170, 2370.166: 12, 2370.913: 60, 2395.1400000000003: 110, 2395.643: 50, 2397.816: 60, 2409.857: 11, 2416.143: 20, 2424.9610000000002: 30, 2436.5009999999997: 70, 2437.161: 40, 2444.786: 20, 2445.939: 30, 2477.6490000000003: 17, 2492.889: 30, 2516.17: 13, 2552.433: 50, 2838.62: 6, 3020.049: 6, 3317.3089999999997: 8, 3335.238: 17, 3389.9809999999998: 5, 3390.3019999999997: 4, 3391.31: 12, 3413.1339999999996: 4, 3447.143: 6, 3583.4809999999998: 8}"}, "ramanchada2.misc.constants.polystyrene_rs": {"fullname": "ramanchada2.misc.constants.polystyrene_rs", "modulename": "ramanchada2.misc.constants", "qualname": "polystyrene_rs", "kind": "variable", "doc": "\n", "default_value": "{620.9: 16, 795.8: 10, 1001.4: 100, 1031.8: 27, 1155.3: 13, 1450.5: 8, 1583.1: 12, 1602.3: 28, 2852.4: 9, 2904.5: 13, 3054.3: 32}"}, "ramanchada2.misc.constants.neon_rs_dict": {"fullname": "ramanchada2.misc.constants.neon_rs_dict", "modulename": "ramanchada2.misc.constants", "qualname": "neon_rs_dict", "kind": "variable", "doc": "\n", "default_value": "{785: {np.float64(122.46893256885171): np.float64(120.0), np.float64(123.92790418673181): np.float64(3.0), np.float64(139.62846387796614): np.float64(13.0), np.float64(149.43939261183922): np.float64(80.0), np.float64(366.3796839579363): np.float64(60.0), np.float64(369.2675936274158): np.float64(100.0), np.float64(421.38180516260735): np.float64(40.0), np.float64(437.0823975157964): np.float64(12.0), np.float64(448.4137962350071): np.float64(170.0), np.float64(631.4057156452395): np.float64(30.0), np.float64(639.3574108984682): np.float64(100.0), np.float64(641.2166700808558): np.float64(70.0), np.float64(642.737084741243): np.float64(10.0), np.float64(691.1336413932653): np.float64(300.0), np.float64(712.3880633377877): np.float64(100.0), np.float64(785.3477634818161): np.float64(50.0), np.float64(794.42757260046): np.float64(100.0), np.float64(802.2720828079191): np.float64(800.0), np.float64(858.3625927463404): np.float64(30.0), np.float64(860.1503620255945): np.float64(250.0), np.float64(923.2117794361885): np.float64(40.0), np.float64(952.5766542670426): np.float64(13.0), np.float64(967.7216907334014): np.float64(700.0), np.float64(1035.6867269022846): np.float64(15.0), np.float64(1072.08315781891): np.float64(30.0), np.float64(1099.115138430138): np.float64(400.0), np.float64(1157.604148115537): np.float64(350.0), np.float64(1174.2039492465462): np.float64(60.0), np.float64(1184.0148919843368): np.float64(600.0), np.float64(1185.5352862129364): np.float64(80.0), np.float64(1202.5075530881757): np.float64(100.0), np.float64(1217.4425451131438): np.float64(130.0), np.float64(1220.665437642399): np.float64(150.0), np.float64(1250.0302210935215): np.float64(30.0), np.float64(1338.4980195800945): np.float64(100.0), np.float64(1350.1394500377296): np.float64(600.0), np.float64(1354.1986085623885): np.float64(400.0), np.float64(1414.9886119309567): np.float64(6.0), np.float64(1444.3533419670161): np.float64(300.0), np.float64(1458.9273939198806): np.float64(20.0), np.float64(1459.498530694608): np.float64(150.0), np.float64(1527.4634843309643): np.float64(60.0), np.float64(1613.5965041854067): np.float64(20.0), np.float64(1724.9850603188252): np.float64(100.0), np.float64(1808.3048539141466): np.float64(120.0), np.float64(1871.3662202368241): np.float64(90.0), np.float64(1892.9372168038894): np.float64(60.0), np.float64(1894.7249573620707): np.float64(20.0), np.float64(1900.7309751098303): np.float64(20.0), np.float64(1957.786316393365): np.float64(9.0), np.float64(1971.7663781767853): np.float64(200.0), np.float64(1987.151135078183): np.float64(80.0), np.float64(1998.388557694021): np.float64(8.0), np.float64(2002.2962579980554): np.float64(30.0), np.float64(2016.7254712832068): np.float64(70.0), np.float64(2070.2611413719483): np.float64(15.0), np.float64(2129.200339961183): np.float64(50.0), np.float64(2167.1455819255425): np.float64(30.0), np.float64(2197.759988274157): np.float64(50.0), np.float64(2250.2557050497553): np.float64(60.0), np.float64(2264.8031148954296): np.float64(30.0), np.float64(2297.184477570986): np.float64(120.0), np.float64(2392.6912977297347): np.float64(180.0), np.float64(2543.988860402575): np.float64(100.0)}, 633: {np.float64(131.15349323856475): np.float64(100.0), np.float64(178.27466380474812): np.float64(200.0), np.float64(428.6085469303318): np.float64(150.0), np.float64(490.60888429816987): np.float64(10.0), np.float64(643.8689658571262): np.float64(100.0), np.float64(764.9250424124886): np.float64(15.0), np.float64(823.8643500376157): np.float64(50.0), np.float64(910.2849841405953): np.float64(7.0), np.float64(1366.664578090937): np.float64(1000.0), np.float64(1560.9884142372662): np.float64(300.0), np.float64(1577.918319348396): np.float64(800.0), np.float64(1615.9907404166095): np.float64(20.0), np.float64(1631.6913325599187): np.float64(100.0), np.float64(1858.4430565740402): np.float64(800.0), np.float64(1934.3157870391897): np.float64(150.0), np.float64(1976.4473852543142): np.float64(150.0), np.float64(1995.483197701751): np.float64(800.0), np.float64(2181.1285988136524): np.float64(150.0), np.float64(2415.276207094919): np.float64(30.0), np.float64(2444.6410422620947): np.float64(300.0), np.float64(2450.3992858353195): np.float64(100.0), np.float64(2504.8972680083675): np.float64(150.0), np.float64(2527.75145967322): np.float64(300.0), np.float64(2542.2988104564824): np.float64(130.0), np.float64(2852.1732140759405): np.float64(1.0), np.float64(2879.1234484825845): np.float64(120.0), np.float64(3041.1452207757484): np.float64(2.0), np.float64(3181.4037390207895): np.float64(120.0), np.float64(3182.86271063867): np.float64(3.0), np.float64(3198.563270329904): np.float64(13.0), np.float64(3208.3741990637773): np.float64(80.0), np.float64(3425.314490409874): np.float64(60.0), np.float64(3428.2024000793535): np.float64(100.0), np.float64(3480.3166116145453): np.float64(40.0), np.float64(3496.0172039677345): np.float64(12.0), np.float64(3507.348602686945): np.float64(170.0), np.float64(3690.340522097177): np.float64(30.0), np.float64(3698.292217350406): np.float64(100.0), np.float64(3700.151476532794): np.float64(70.0), np.float64(3701.671891193181): np.float64(10.0), np.float64(3750.068447845203): np.float64(300.0), np.float64(3771.3228697897257): np.float64(100.0), np.float64(3844.282569933754): np.float64(50.0), np.float64(3853.362379052398): np.float64(100.0), np.float64(3861.206889259857): np.float64(800.0), np.float64(3917.2973991982785): np.float64(30.0), np.float64(3919.0851684775325): np.float64(250.0), np.float64(3982.1465858881265): np.float64(40.0), np.float64(4011.5114607189803): np.float64(13.0), np.float64(4026.6564971853395): np.float64(700.0), np.float64(4094.6215333542223): np.float64(15.0), np.float64(4131.017964270848): np.float64(30.0), np.float64(4158.049944882076): np.float64(400.0), np.float64(4216.538954567475): np.float64(350.0), np.float64(4233.138755698485): np.float64(60.0), np.float64(4242.949698436275): np.float64(600.0), np.float64(4244.470092664874): np.float64(80.0), np.float64(4261.442359540114): np.float64(100.0), np.float64(4276.377351565082): np.float64(130.0), np.float64(4279.600244094337): np.float64(150.0), np.float64(4308.96502754546): np.float64(30.0), np.float64(4397.432826032033): np.float64(100.0), np.float64(4409.074256489667): np.float64(600.0), np.float64(4413.133415014327): np.float64(400.0), np.float64(4473.923418382895): np.float64(6.0)}, 532: {np.float64(280.400374063339): np.float64(200.0), np.float64(820.3246859611342): np.float64(50.0), np.float64(1118.7121507719057): np.float64(50.0), np.float64(1312.1053685299726): np.float64(50.0), np.float64(1400.5402962651492): np.float64(50.0), np.float64(1449.1897851185397): np.float64(70.0), np.float64(1568.8301417453613): np.float64(50.0), np.float64(1615.3218462004172): np.float64(50.0), np.float64(1710.2420754482148): np.float64(200.0), np.float64(1769.419306271512): np.float64(50.0), np.float64(1795.6695062543874): np.float64(100.0), np.float64(1854.9105300823699): np.float64(5.0), np.float64(1866.2898133610774): np.float64(5.0), np.float64(1975.6654877605317): np.float64(50.0), np.float64(2033.8567623301808): np.float64(50.0), np.float64(2059.546783125738): np.float64(50.0), np.float64(2062.0864460269026): np.float64(60.0), np.float64(2096.667422736005): np.float64(15.0), np.float64(2213.236028525559): np.float64(100.0), np.float64(2334.292358356692): np.float64(100.0), np.float64(2393.2318928421078): np.float64(30.0), np.float64(2479.652593999227): np.float64(10.0), np.float64(2518.4671736471323): np.float64(100.0), np.float64(2572.691915262086): np.float64(100.0), np.float64(2621.3796761996955): np.float64(15.0), np.float64(2712.79156071062): np.float64(100.0), np.float64(2839.1085285308986): np.float64(100.0), np.float64(2936.033203089824): np.float64(10.0), np.float64(2994.6222331219114): np.float64(30.0), np.float64(3010.246912802971): np.float64(100.0), np.float64(3130.3576648049207): np.float64(100.0), np.float64(3177.4788353711037): np.float64(200.0), np.float64(3427.8127184966875): np.float64(150.0), np.float64(3489.8130558645257): np.float64(10.0), np.float64(3643.073137423482): np.float64(100.0), np.float64(3764.1292139788443): np.float64(15.0), np.float64(3823.0685216039715): np.float64(50.0), np.float64(3909.4891557069514): np.float64(7.0)}, 514: {np.float64(696.2632587120148): np.float64(60.0), np.float64(732.4961676014019): np.float64(100.0), np.float64(740.1684816286361): np.float64(60.0), np.float64(938.6608111482706): np.float64(200.0), np.float64(1478.5851230460657): np.float64(50.0), np.float64(1776.9725878568374): np.float64(50.0), np.float64(1970.3658056149043): np.float64(50.0), np.float64(2058.800733350081): np.float64(50.0), np.float64(2107.450222203471): np.float64(70.0), np.float64(2227.090578830293): np.float64(50.0), np.float64(2273.5822832853487): np.float64(50.0), np.float64(2368.5025125331463): np.float64(200.0), np.float64(2427.6797433564434): np.float64(50.0), np.float64(2453.929943339319): np.float64(100.0), np.float64(2513.1709671673016): np.float64(5.0), np.float64(2524.550250446009): np.float64(5.0), np.float64(2633.925924845463): np.float64(50.0), np.float64(2692.1171994151123): np.float64(50.0), np.float64(2717.8072202106696): np.float64(50.0), np.float64(2720.3468831118344): np.float64(60.0), np.float64(2754.9278598209366): np.float64(15.0), np.float64(2871.4964656104908): np.float64(100.0), np.float64(2992.5527954416234): np.float64(100.0), np.float64(3051.492329927039): np.float64(30.0), np.float64(3137.913031084159): np.float64(10.0), np.float64(3176.7276107320636): np.float64(100.0), np.float64(3230.9523523470175): np.float64(100.0), np.float64(3279.640113284627): np.float64(15.0), np.float64(3371.051997795552): np.float64(100.0), np.float64(3497.3689656158303): np.float64(100.0), np.float64(3594.293640174755): np.float64(10.0), np.float64(3652.8826702068427): np.float64(30.0), np.float64(3668.507349887903): np.float64(100.0), np.float64(3788.618101889852): np.float64(100.0), np.float64(3835.7392724560355): np.float64(200.0)}}"}, "ramanchada2.misc.constants.neon_wl_dict": {"fullname": "ramanchada2.misc.constants.neon_wl_dict", "modulename": "ramanchada2.misc.constants", "qualname": "neon_wl_dict", "kind": "variable", "doc": "\n", "default_value": "{785: {np.float64(792.6201): np.float64(120.0), np.float64(792.71177): np.float64(3.0), np.float64(793.69961): np.float64(13.0), np.float64(794.3181400000001): np.float64(80.0), np.float64(808.2457999999999): np.float64(60.0), np.float64(808.4345000000001): np.float64(100.0), np.float64(811.85492): np.float64(40.0), np.float64(812.89108): np.float64(12.0), np.float64(813.64054): np.float64(170.0), np.float64(825.9379000000001): np.float64(30.0), np.float64(826.4807): np.float64(100.0), np.float64(826.60772): np.float64(70.0), np.float64(826.7116200000002): np.float64(10.0), np.float64(830.0325800000002): np.float64(300.0), np.float64(831.4995000000001): np.float64(100.0), np.float64(836.5746600000001): np.float64(50.0), np.float64(837.2106): np.float64(100.0), np.float64(837.7608000000001): np.float64(800.0), np.float64(841.7160600000001): np.float64(30.0), np.float64(841.84274): np.float64(250.0), np.float64(846.33575): np.float64(40.0), np.float64(848.4443499999999): np.float64(13.0), np.float64(849.5359799999999): np.float64(700.0), np.float64(854.46958): np.float64(15.0), np.float64(857.13524): np.float64(30.0), np.float64(859.1258399999999): np.float64(400.0), np.float64(863.4647000000001): np.float64(350.0), np.float64(864.7041100000001): np.float64(60.0), np.float64(865.43831): np.float64(600.0), np.float64(865.5522000000001): np.float64(80.0), np.float64(866.8255999999999): np.float64(100.0), np.float64(867.94925): np.float64(130.0), np.float64(868.1921100000001): np.float64(150.0), np.float64(870.4111599999999): np.float64(30.0), np.float64(877.1656300000001): np.float64(100.0), np.float64(878.06226): np.float64(600.0), np.float64(878.3753300000001): np.float64(400.0), np.float64(883.0907199999999): np.float64(6.0), np.float64(885.3866799999998): np.float64(300.0), np.float64(886.53063): np.float64(20.0), np.float64(886.57552): np.float64(150.0), np.float64(891.9500599999998): np.float64(60.0), np.float64(898.85564): np.float64(20.0), np.float64(907.9462): np.float64(100.0), np.float64(914.8671600000001): np.float64(120.0), np.float64(920.1759099999999): np.float64(90.0), np.float64(922.00601): np.float64(60.0), np.float64(922.1580099999999): np.float64(20.0), np.float64(922.66903): np.float64(20.0), np.float64(927.5519599999999): np.float64(9.0), np.float64(928.7563): np.float64(200.0), np.float64(930.0852699999999): np.float64(80.0), np.float64(931.0583899999999): np.float64(8.0), np.float64(931.39726): np.float64(30.0), np.float64(932.6506799999999): np.float64(70.0), np.float64(937.3307799999999): np.float64(15.0), np.float64(942.5378800000001): np.float64(50.0), np.float64(945.9209500000001): np.float64(30.0), np.float64(948.66818): np.float64(50.0), np.float64(953.41629): np.float64(60.0), np.float64(954.74049): np.float64(30.0), np.float64(957.7013000000001): np.float64(120.0), np.float64(966.5419700000001): np.float64(180.0), np.float64(980.8860000000001): np.float64(100.0)}, 633: {np.float64(638.29917): np.float64(100.0), np.float64(640.2248): np.float64(200.0), np.float64(650.65281): np.float64(150.0), np.float64(653.28822): np.float64(10.0), np.float64(659.89529): np.float64(100.0), np.float64(665.2092700000001): np.float64(15.0), np.float64(667.82762): np.float64(50.0), np.float64(671.7043): np.float64(7.0), np.float64(692.94673): np.float64(1000.0), np.float64(702.40504): np.float64(300.0), np.float64(703.24131): np.float64(800.0), np.float64(705.12923): np.float64(20.0), np.float64(705.91074): np.float64(100.0), np.float64(717.39381): np.float64(800.0), np.float64(721.3199999999999): np.float64(150.0), np.float64(723.5188): np.float64(150.0), np.float64(724.51666): np.float64(800.0), np.float64(734.3945): np.float64(150.0), np.float64(747.24386): np.float64(30.0), np.float64(748.8871199999999): np.float64(300.0), np.float64(749.2102): np.float64(100.0), np.float64(752.2818): np.float64(150.0), np.float64(753.57741): np.float64(300.0), np.float64(754.4044299999999): np.float64(130.0), np.float64(772.4623300000001): np.float64(1.0), np.float64(774.0738): np.float64(120.0), np.float64(783.9052899999999): np.float64(2.0), np.float64(792.6201): np.float64(120.0), np.float64(792.71177): np.float64(3.0), np.float64(793.69961): np.float64(13.0), np.float64(794.3181400000001): np.float64(80.0), np.float64(808.2457999999999): np.float64(60.0), np.float64(808.4345000000001): np.float64(100.0), np.float64(811.85492): np.float64(40.0), np.float64(812.89108): np.float64(12.0), np.float64(813.64054): np.float64(170.0), np.float64(825.9379000000001): np.float64(30.0), np.float64(826.4807): np.float64(100.0), np.float64(826.60772): np.float64(70.0), np.float64(826.7116200000002): np.float64(10.0), np.float64(830.0325800000002): np.float64(300.0), np.float64(831.4995000000001): np.float64(100.0), np.float64(836.5746600000001): np.float64(50.0), np.float64(837.2106): np.float64(100.0), np.float64(837.7608000000001): np.float64(800.0), np.float64(841.7160600000001): np.float64(30.0), np.float64(841.84274): np.float64(250.0), np.float64(846.33575): np.float64(40.0), np.float64(848.4443499999999): np.float64(13.0), np.float64(849.5359799999999): np.float64(700.0), np.float64(854.46958): np.float64(15.0), np.float64(857.13524): np.float64(30.0), np.float64(859.1258399999999): np.float64(400.0), np.float64(863.4647000000001): np.float64(350.0), np.float64(864.7041100000001): np.float64(60.0), np.float64(865.43831): np.float64(600.0), np.float64(865.5522000000001): np.float64(80.0), np.float64(866.8255999999999): np.float64(100.0), np.float64(867.94925): np.float64(130.0), np.float64(868.1921100000001): np.float64(150.0), np.float64(870.4111599999999): np.float64(30.0), np.float64(877.1656300000001): np.float64(100.0), np.float64(878.06226): np.float64(600.0), np.float64(878.3753300000001): np.float64(400.0), np.float64(883.0907199999999): np.float64(6.0)}, 532: {np.float64(540.05618): np.float64(200.0), np.float64(556.27662): np.float64(50.0), np.float64(565.66588): np.float64(50.0), np.float64(571.92248): np.float64(50.0), np.float64(574.82985): np.float64(50.0), np.float64(576.4418800000001): np.float64(70.0), np.float64(580.44496): np.float64(50.0), np.float64(582.01558): np.float64(50.0), np.float64(585.24879): np.float64(200.0), np.float64(587.2827500000001): np.float64(50.0), np.float64(588.18952): np.float64(100.0), np.float64(590.24623): np.float64(5.0), np.float64(590.64294): np.float64(5.0), np.float64(594.48342): np.float64(50.0), np.float64(596.5471): np.float64(50.0), np.float64(597.46273): np.float64(50.0), np.float64(597.5534): np.float64(60.0), np.float64(598.79074): np.float64(15.0), np.float64(602.99969): np.float64(100.0), np.float64(607.43377): np.float64(100.0), np.float64(609.61631): np.float64(30.0), np.float64(612.8449899999999): np.float64(10.0), np.float64(614.3062600000001): np.float64(100.0), np.float64(616.35939): np.float64(100.0), np.float64(618.2146): np.float64(15.0), np.float64(621.72812): np.float64(100.0), np.float64(626.6495): np.float64(100.0), np.float64(630.47889): np.float64(10.0), np.float64(632.81646): np.float64(30.0), np.float64(633.4427800000001): np.float64(100.0), np.float64(638.29917): np.float64(100.0), np.float64(640.2248): np.float64(200.0), np.float64(650.65281): np.float64(150.0), np.float64(653.28822): np.float64(10.0), np.float64(659.89529): np.float64(100.0), np.float64(665.2092700000001): np.float64(15.0), np.float64(667.82762): np.float64(50.0), np.float64(671.7043): np.float64(7.0)}, 514: {np.float64(533.07775): np.float64(60.0), np.float64(534.10938): np.float64(100.0), np.float64(534.32834): np.float64(60.0), np.float64(540.05618): np.float64(200.0), np.float64(556.27662): np.float64(50.0), np.float64(565.66588): np.float64(50.0), np.float64(571.92248): np.float64(50.0), np.float64(574.82985): np.float64(50.0), np.float64(576.4418800000001): np.float64(70.0), np.float64(580.44496): np.float64(50.0), np.float64(582.01558): np.float64(50.0), np.float64(585.24879): np.float64(200.0), np.float64(587.2827500000001): np.float64(50.0), np.float64(588.18952): np.float64(100.0), np.float64(590.24623): np.float64(5.0), np.float64(590.64294): np.float64(5.0), np.float64(594.48342): np.float64(50.0), np.float64(596.5471): np.float64(50.0), np.float64(597.46273): np.float64(50.0), np.float64(597.5534): np.float64(60.0), np.float64(598.79074): np.float64(15.0), np.float64(602.99969): np.float64(100.0), np.float64(607.43377): np.float64(100.0), np.float64(609.61631): np.float64(30.0), np.float64(612.8449899999999): np.float64(10.0), np.float64(614.3062600000001): np.float64(100.0), np.float64(616.35939): np.float64(100.0), np.float64(618.2146): np.float64(15.0), np.float64(621.72812): np.float64(100.0), np.float64(626.6495): np.float64(100.0), np.float64(630.47889): np.float64(10.0), np.float64(632.81646): np.float64(30.0), np.float64(633.4427800000001): np.float64(100.0), np.float64(638.29917): np.float64(100.0), np.float64(640.2248): np.float64(200.0)}}"}, "ramanchada2.misc.constants.neon_rs_spe": {"fullname": "ramanchada2.misc.constants.neon_rs_spe", "modulename": "ramanchada2.misc.constants", "qualname": "neon_rs_spe", "kind": "variable", "doc": "\n", "default_value": "{785: from_delta_lines({np.float64(122.46893256885171): np.float64(120.0), np.float64(123.92790418673181): np.float64(3.0), np.float64(139.62846387796614): np.float64(13.0), np.float64(149.43939261183922): np.float64(80.0), np.float64(366.3796839579363): np.float64(60.0), np.float64(369.2675936274158): np.float64(100.0), np.float64(421.38180516260735): np.float64(40.0), np.float64(437.0823975157964): np.float64(12.0), np.float64(448.4137962350071): np.float64(170.0), np.float64(631.4057156452395): np.float64(30.0), np.float64(639.3574108984682): np.float64(100.0), np.float64(641.2166700808558): np.float64(70.0), np.float64(642.737084741243): np.float64(10.0), np.float64(691.1336413932653): np.float64(300.0), np.float64(712.3880633377877): np.float64(100.0), np.float64(785.3477634818161): np.float64(50.0), np.float64(794.42757260046): np.float64(100.0), np.float64(802.2720828079191): np.float64(800.0), np.float64(858.3625927463404): np.float64(30.0), np.float64(860.1503620255945): np.float64(250.0), np.float64(923.2117794361885): np.float64(40.0), np.float64(952.5766542670426): np.float64(13.0), np.float64(967.7216907334014): np.float64(700.0), np.float64(1035.6867269022846): np.float64(15.0), np.float64(1072.08315781891): np.float64(30.0), np.float64(1099.115138430138): np.float64(400.0), np.float64(1157.604148115537): np.float64(350.0), np.float64(1174.2039492465462): np.float64(60.0), np.float64(1184.0148919843368): np.float64(600.0), np.float64(1185.5352862129364): np.float64(80.0), np.float64(1202.5075530881757): np.float64(100.0), np.float64(1217.4425451131438): np.float64(130.0), np.float64(1220.665437642399): np.float64(150.0), np.float64(1250.0302210935215): np.float64(30.0), np.float64(1338.4980195800945): np.float64(100.0), np.float64(1350.1394500377296): np.float64(600.0), np.float64(1354.1986085623885): np.float64(400.0), np.float64(1414.9886119309567): np.float64(6.0), np.float64(1444.3533419670161): np.float64(300.0), np.float64(1458.9273939198806): np.float64(20.0), np.float64(1459.498530694608): np.float64(150.0), np.float64(1527.4634843309643): np.float64(60.0), np.float64(1613.5965041854067): np.float64(20.0), np.float64(1724.9850603188252): np.float64(100.0), np.float64(1808.3048539141466): np.float64(120.0), np.float64(1871.3662202368241): np.float64(90.0), np.float64(1892.9372168038894): np.float64(60.0), np.float64(1894.7249573620707): np.float64(20.0), np.float64(1900.7309751098303): np.float64(20.0), np.float64(1957.786316393365): np.float64(9.0), np.float64(1971.7663781767853): np.float64(200.0), np.float64(1987.151135078183): np.float64(80.0), np.float64(1998.388557694021): np.float64(8.0), np.float64(2002.2962579980554): np.float64(30.0), np.float64(2016.7254712832068): np.float64(70.0), np.float64(2070.2611413719483): np.float64(15.0), np.float64(2129.200339961183): np.float64(50.0), np.float64(2167.1455819255425): np.float64(30.0), np.float64(2197.759988274157): np.float64(50.0), np.float64(2250.2557050497553): np.float64(60.0), np.float64(2264.8031148954296): np.float64(30.0), np.float64(2297.184477570986): np.float64(120.0), np.float64(2392.6912977297347): np.float64(180.0), np.float64(2543.988860402575): np.float64(100.0)}, xcal=<function <lambda>>, nbins=4500).convolve('gaussian', sigma=1), 633: from_delta_lines({np.float64(131.15349323856475): np.float64(100.0), np.float64(178.27466380474812): np.float64(200.0), np.float64(428.6085469303318): np.float64(150.0), np.float64(490.60888429816987): np.float64(10.0), np.float64(643.8689658571262): np.float64(100.0), np.float64(764.9250424124886): np.float64(15.0), np.float64(823.8643500376157): np.float64(50.0), np.float64(910.2849841405953): np.float64(7.0), np.float64(1366.664578090937): np.float64(1000.0), np.float64(1560.9884142372662): np.float64(300.0), np.float64(1577.918319348396): np.float64(800.0), np.float64(1615.9907404166095): np.float64(20.0), np.float64(1631.6913325599187): np.float64(100.0), np.float64(1858.4430565740402): np.float64(800.0), np.float64(1934.3157870391897): np.float64(150.0), np.float64(1976.4473852543142): np.float64(150.0), np.float64(1995.483197701751): np.float64(800.0), np.float64(2181.1285988136524): np.float64(150.0), np.float64(2415.276207094919): np.float64(30.0), np.float64(2444.6410422620947): np.float64(300.0), np.float64(2450.3992858353195): np.float64(100.0), np.float64(2504.8972680083675): np.float64(150.0), np.float64(2527.75145967322): np.float64(300.0), np.float64(2542.2988104564824): np.float64(130.0), np.float64(2852.1732140759405): np.float64(1.0), np.float64(2879.1234484825845): np.float64(120.0), np.float64(3041.1452207757484): np.float64(2.0), np.float64(3181.4037390207895): np.float64(120.0), np.float64(3182.86271063867): np.float64(3.0), np.float64(3198.563270329904): np.float64(13.0), np.float64(3208.3741990637773): np.float64(80.0), np.float64(3425.314490409874): np.float64(60.0), np.float64(3428.2024000793535): np.float64(100.0), np.float64(3480.3166116145453): np.float64(40.0), np.float64(3496.0172039677345): np.float64(12.0), np.float64(3507.348602686945): np.float64(170.0), np.float64(3690.340522097177): np.float64(30.0), np.float64(3698.292217350406): np.float64(100.0), np.float64(3700.151476532794): np.float64(70.0), np.float64(3701.671891193181): np.float64(10.0), np.float64(3750.068447845203): np.float64(300.0), np.float64(3771.3228697897257): np.float64(100.0), np.float64(3844.282569933754): np.float64(50.0), np.float64(3853.362379052398): np.float64(100.0), np.float64(3861.206889259857): np.float64(800.0), np.float64(3917.2973991982785): np.float64(30.0), np.float64(3919.0851684775325): np.float64(250.0), np.float64(3982.1465858881265): np.float64(40.0), np.float64(4011.5114607189803): np.float64(13.0), np.float64(4026.6564971853395): np.float64(700.0), np.float64(4094.6215333542223): np.float64(15.0), np.float64(4131.017964270848): np.float64(30.0), np.float64(4158.049944882076): np.float64(400.0), np.float64(4216.538954567475): np.float64(350.0), np.float64(4233.138755698485): np.float64(60.0), np.float64(4242.949698436275): np.float64(600.0), np.float64(4244.470092664874): np.float64(80.0), np.float64(4261.442359540114): np.float64(100.0), np.float64(4276.377351565082): np.float64(130.0), np.float64(4279.600244094337): np.float64(150.0), np.float64(4308.96502754546): np.float64(30.0), np.float64(4397.432826032033): np.float64(100.0), np.float64(4409.074256489667): np.float64(600.0), np.float64(4413.133415014327): np.float64(400.0), np.float64(4473.923418382895): np.float64(6.0)}, xcal=<function <lambda>>, nbins=4500).convolve('gaussian', sigma=2), 532: from_delta_lines({np.float64(280.400374063339): np.float64(200.0), np.float64(820.3246859611342): np.float64(50.0), np.float64(1118.7121507719057): np.float64(50.0), np.float64(1312.1053685299726): np.float64(50.0), np.float64(1400.5402962651492): np.float64(50.0), np.float64(1449.1897851185397): np.float64(70.0), np.float64(1568.8301417453613): np.float64(50.0), np.float64(1615.3218462004172): np.float64(50.0), np.float64(1710.2420754482148): np.float64(200.0), np.float64(1769.419306271512): np.float64(50.0), np.float64(1795.6695062543874): np.float64(100.0), np.float64(1854.9105300823699): np.float64(5.0), np.float64(1866.2898133610774): np.float64(5.0), np.float64(1975.6654877605317): np.float64(50.0), np.float64(2033.8567623301808): np.float64(50.0), np.float64(2059.546783125738): np.float64(50.0), np.float64(2062.0864460269026): np.float64(60.0), np.float64(2096.667422736005): np.float64(15.0), np.float64(2213.236028525559): np.float64(100.0), np.float64(2334.292358356692): np.float64(100.0), np.float64(2393.2318928421078): np.float64(30.0), np.float64(2479.652593999227): np.float64(10.0), np.float64(2518.4671736471323): np.float64(100.0), np.float64(2572.691915262086): np.float64(100.0), np.float64(2621.3796761996955): np.float64(15.0), np.float64(2712.79156071062): np.float64(100.0), np.float64(2839.1085285308986): np.float64(100.0), np.float64(2936.033203089824): np.float64(10.0), np.float64(2994.6222331219114): np.float64(30.0), np.float64(3010.246912802971): np.float64(100.0), np.float64(3130.3576648049207): np.float64(100.0), np.float64(3177.4788353711037): np.float64(200.0), np.float64(3427.8127184966875): np.float64(150.0), np.float64(3489.8130558645257): np.float64(10.0), np.float64(3643.073137423482): np.float64(100.0), np.float64(3764.1292139788443): np.float64(15.0), np.float64(3823.0685216039715): np.float64(50.0), np.float64(3909.4891557069514): np.float64(7.0)}, xcal=<function <lambda>>, nbins=4500).convolve('gaussian', sigma=3), 514: from_delta_lines({np.float64(696.2632587120148): np.float64(60.0), np.float64(732.4961676014019): np.float64(100.0), np.float64(740.1684816286361): np.float64(60.0), np.float64(938.6608111482706): np.float64(200.0), np.float64(1478.5851230460657): np.float64(50.0), np.float64(1776.9725878568374): np.float64(50.0), np.float64(1970.3658056149043): np.float64(50.0), np.float64(2058.800733350081): np.float64(50.0), np.float64(2107.450222203471): np.float64(70.0), np.float64(2227.090578830293): np.float64(50.0), np.float64(2273.5822832853487): np.float64(50.0), np.float64(2368.5025125331463): np.float64(200.0), np.float64(2427.6797433564434): np.float64(50.0), np.float64(2453.929943339319): np.float64(100.0), np.float64(2513.1709671673016): np.float64(5.0), np.float64(2524.550250446009): np.float64(5.0), np.float64(2633.925924845463): np.float64(50.0), np.float64(2692.1171994151123): np.float64(50.0), np.float64(2717.8072202106696): np.float64(50.0), np.float64(2720.3468831118344): np.float64(60.0), np.float64(2754.9278598209366): np.float64(15.0), np.float64(2871.4964656104908): np.float64(100.0), np.float64(2992.5527954416234): np.float64(100.0), np.float64(3051.492329927039): np.float64(30.0), np.float64(3137.913031084159): np.float64(10.0), np.float64(3176.7276107320636): np.float64(100.0), np.float64(3230.9523523470175): np.float64(100.0), np.float64(3279.640113284627): np.float64(15.0), np.float64(3371.051997795552): np.float64(100.0), np.float64(3497.3689656158303): np.float64(100.0), np.float64(3594.293640174755): np.float64(10.0), np.float64(3652.8826702068427): np.float64(30.0), np.float64(3668.507349887903): np.float64(100.0), np.float64(3788.618101889852): np.float64(100.0), np.float64(3835.7392724560355): np.float64(200.0)}, xcal=<function <lambda>>, nbins=4500).convolve('gaussian', sigma=3)}"}, "ramanchada2.misc.constants.neon_wl_spe": {"fullname": "ramanchada2.misc.constants.neon_wl_spe", "modulename": "ramanchada2.misc.constants", "qualname": "neon_wl_spe", "kind": "variable", "doc": "\n", "default_value": "{785: from_delta_lines({np.float64(792.6201): np.float64(120.0), np.float64(792.71177): np.float64(3.0), np.float64(793.69961): np.float64(13.0), np.float64(794.3181400000001): np.float64(80.0), np.float64(808.2457999999999): np.float64(60.0), np.float64(808.4345000000001): np.float64(100.0), np.float64(811.85492): np.float64(40.0), np.float64(812.89108): np.float64(12.0), np.float64(813.64054): np.float64(170.0), np.float64(825.9379000000001): np.float64(30.0), np.float64(826.4807): np.float64(100.0), np.float64(826.60772): np.float64(70.0), np.float64(826.7116200000002): np.float64(10.0), np.float64(830.0325800000002): np.float64(300.0), np.float64(831.4995000000001): np.float64(100.0), np.float64(836.5746600000001): np.float64(50.0), np.float64(837.2106): np.float64(100.0), np.float64(837.7608000000001): np.float64(800.0), np.float64(841.7160600000001): np.float64(30.0), np.float64(841.84274): np.float64(250.0), np.float64(846.33575): np.float64(40.0), np.float64(848.4443499999999): np.float64(13.0), np.float64(849.5359799999999): np.float64(700.0), np.float64(854.46958): np.float64(15.0), np.float64(857.13524): np.float64(30.0), np.float64(859.1258399999999): np.float64(400.0), np.float64(863.4647000000001): np.float64(350.0), np.float64(864.7041100000001): np.float64(60.0), np.float64(865.43831): np.float64(600.0), np.float64(865.5522000000001): np.float64(80.0), np.float64(866.8255999999999): np.float64(100.0), np.float64(867.94925): np.float64(130.0), np.float64(868.1921100000001): np.float64(150.0), np.float64(870.4111599999999): np.float64(30.0), np.float64(877.1656300000001): np.float64(100.0), np.float64(878.06226): np.float64(600.0), np.float64(878.3753300000001): np.float64(400.0), np.float64(883.0907199999999): np.float64(6.0), np.float64(885.3866799999998): np.float64(300.0), np.float64(886.53063): np.float64(20.0), np.float64(886.57552): np.float64(150.0), np.float64(891.9500599999998): np.float64(60.0), np.float64(898.85564): np.float64(20.0), np.float64(907.9462): np.float64(100.0), np.float64(914.8671600000001): np.float64(120.0), np.float64(920.1759099999999): np.float64(90.0), np.float64(922.00601): np.float64(60.0), np.float64(922.1580099999999): np.float64(20.0), np.float64(922.66903): np.float64(20.0), np.float64(927.5519599999999): np.float64(9.0), np.float64(928.7563): np.float64(200.0), np.float64(930.0852699999999): np.float64(80.0), np.float64(931.0583899999999): np.float64(8.0), np.float64(931.39726): np.float64(30.0), np.float64(932.6506799999999): np.float64(70.0), np.float64(937.3307799999999): np.float64(15.0), np.float64(942.5378800000001): np.float64(50.0), np.float64(945.9209500000001): np.float64(30.0), np.float64(948.66818): np.float64(50.0), np.float64(953.41629): np.float64(60.0), np.float64(954.74049): np.float64(30.0), np.float64(957.7013000000001): np.float64(120.0), np.float64(966.5419700000001): np.float64(180.0), np.float64(980.8860000000001): np.float64(100.0)}, xcal=<function <lambda>>, nbins=4500).convolve('gaussian', sigma=1.5), 633: from_delta_lines({np.float64(638.29917): np.float64(100.0), np.float64(640.2248): np.float64(200.0), np.float64(650.65281): np.float64(150.0), np.float64(653.28822): np.float64(10.0), np.float64(659.89529): np.float64(100.0), np.float64(665.2092700000001): np.float64(15.0), np.float64(667.82762): np.float64(50.0), np.float64(671.7043): np.float64(7.0), np.float64(692.94673): np.float64(1000.0), np.float64(702.40504): np.float64(300.0), np.float64(703.24131): np.float64(800.0), np.float64(705.12923): np.float64(20.0), np.float64(705.91074): np.float64(100.0), np.float64(717.39381): np.float64(800.0), np.float64(721.3199999999999): np.float64(150.0), np.float64(723.5188): np.float64(150.0), np.float64(724.51666): np.float64(800.0), np.float64(734.3945): np.float64(150.0), np.float64(747.24386): np.float64(30.0), np.float64(748.8871199999999): np.float64(300.0), np.float64(749.2102): np.float64(100.0), np.float64(752.2818): np.float64(150.0), np.float64(753.57741): np.float64(300.0), np.float64(754.4044299999999): np.float64(130.0), np.float64(772.4623300000001): np.float64(1.0), np.float64(774.0738): np.float64(120.0), np.float64(783.9052899999999): np.float64(2.0), np.float64(792.6201): np.float64(120.0), np.float64(792.71177): np.float64(3.0), np.float64(793.69961): np.float64(13.0), np.float64(794.3181400000001): np.float64(80.0), np.float64(808.2457999999999): np.float64(60.0), np.float64(808.4345000000001): np.float64(100.0), np.float64(811.85492): np.float64(40.0), np.float64(812.89108): np.float64(12.0), np.float64(813.64054): np.float64(170.0), np.float64(825.9379000000001): np.float64(30.0), np.float64(826.4807): np.float64(100.0), np.float64(826.60772): np.float64(70.0), np.float64(826.7116200000002): np.float64(10.0), np.float64(830.0325800000002): np.float64(300.0), np.float64(831.4995000000001): np.float64(100.0), np.float64(836.5746600000001): np.float64(50.0), np.float64(837.2106): np.float64(100.0), np.float64(837.7608000000001): np.float64(800.0), np.float64(841.7160600000001): np.float64(30.0), np.float64(841.84274): np.float64(250.0), np.float64(846.33575): np.float64(40.0), np.float64(848.4443499999999): np.float64(13.0), np.float64(849.5359799999999): np.float64(700.0), np.float64(854.46958): np.float64(15.0), np.float64(857.13524): np.float64(30.0), np.float64(859.1258399999999): np.float64(400.0), np.float64(863.4647000000001): np.float64(350.0), np.float64(864.7041100000001): np.float64(60.0), np.float64(865.43831): np.float64(600.0), np.float64(865.5522000000001): np.float64(80.0), np.float64(866.8255999999999): np.float64(100.0), np.float64(867.94925): np.float64(130.0), np.float64(868.1921100000001): np.float64(150.0), np.float64(870.4111599999999): np.float64(30.0), np.float64(877.1656300000001): np.float64(100.0), np.float64(878.06226): np.float64(600.0), np.float64(878.3753300000001): np.float64(400.0), np.float64(883.0907199999999): np.float64(6.0)}, xcal=<function <lambda>>, nbins=4500).convolve('gaussian', sigma=1.5), 532: from_delta_lines({np.float64(540.05618): np.float64(200.0), np.float64(556.27662): np.float64(50.0), np.float64(565.66588): np.float64(50.0), np.float64(571.92248): np.float64(50.0), np.float64(574.82985): np.float64(50.0), np.float64(576.4418800000001): np.float64(70.0), np.float64(580.44496): np.float64(50.0), np.float64(582.01558): np.float64(50.0), np.float64(585.24879): np.float64(200.0), np.float64(587.2827500000001): np.float64(50.0), np.float64(588.18952): np.float64(100.0), np.float64(590.24623): np.float64(5.0), np.float64(590.64294): np.float64(5.0), np.float64(594.48342): np.float64(50.0), np.float64(596.5471): np.float64(50.0), np.float64(597.46273): np.float64(50.0), np.float64(597.5534): np.float64(60.0), np.float64(598.79074): np.float64(15.0), np.float64(602.99969): np.float64(100.0), np.float64(607.43377): np.float64(100.0), np.float64(609.61631): np.float64(30.0), np.float64(612.8449899999999): np.float64(10.0), np.float64(614.3062600000001): np.float64(100.0), np.float64(616.35939): np.float64(100.0), np.float64(618.2146): np.float64(15.0), np.float64(621.72812): np.float64(100.0), np.float64(626.6495): np.float64(100.0), np.float64(630.47889): np.float64(10.0), np.float64(632.81646): np.float64(30.0), np.float64(633.4427800000001): np.float64(100.0), np.float64(638.29917): np.float64(100.0), np.float64(640.2248): np.float64(200.0), np.float64(650.65281): np.float64(150.0), np.float64(653.28822): np.float64(10.0), np.float64(659.89529): np.float64(100.0), np.float64(665.2092700000001): np.float64(15.0), np.float64(667.82762): np.float64(50.0), np.float64(671.7043): np.float64(7.0)}, xcal=<function <lambda>>, nbins=4500).convolve('gaussian', sigma=1.5), 514: from_delta_lines({np.float64(533.07775): np.float64(60.0), np.float64(534.10938): np.float64(100.0), np.float64(534.32834): np.float64(60.0), np.float64(540.05618): np.float64(200.0), np.float64(556.27662): np.float64(50.0), np.float64(565.66588): np.float64(50.0), np.float64(571.92248): np.float64(50.0), np.float64(574.82985): np.float64(50.0), np.float64(576.4418800000001): np.float64(70.0), np.float64(580.44496): np.float64(50.0), np.float64(582.01558): np.float64(50.0), np.float64(585.24879): np.float64(200.0), np.float64(587.2827500000001): np.float64(50.0), np.float64(588.18952): np.float64(100.0), np.float64(590.24623): np.float64(5.0), np.float64(590.64294): np.float64(5.0), np.float64(594.48342): np.float64(50.0), np.float64(596.5471): np.float64(50.0), np.float64(597.46273): np.float64(50.0), np.float64(597.5534): np.float64(60.0), np.float64(598.79074): np.float64(15.0), np.float64(602.99969): np.float64(100.0), np.float64(607.43377): np.float64(100.0), np.float64(609.61631): np.float64(30.0), np.float64(612.8449899999999): np.float64(10.0), np.float64(614.3062600000001): np.float64(100.0), np.float64(616.35939): np.float64(100.0), np.float64(618.2146): np.float64(15.0), np.float64(621.72812): np.float64(100.0), np.float64(626.6495): np.float64(100.0), np.float64(630.47889): np.float64(10.0), np.float64(632.81646): np.float64(30.0), np.float64(633.4427800000001): np.float64(100.0), np.float64(638.29917): np.float64(100.0), np.float64(640.2248): np.float64(200.0)}, xcal=<function <lambda>>, nbins=4500).convolve('gaussian', sigma=1.5)}"}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"fullname": "ramanchada2.misc.constants.neon_wl_785_nist_dict", "modulename": "ramanchada2.misc.constants", "qualname": "neon_wl_785_nist_dict", "kind": "variable", "doc": "\n", "default_value": "{792.6841221569385: 5.37437266023976, 793.7330415754924: 0.5689277951354417, 794.3457330415755: 3.501094091821991, 808.4285595693893: 7.202537154952434, 811.8949671772428: 1.7505470455873593, 812.945295404814: 0.5251641209139684, 813.6892778993436: 7.439824945294173, 825.9868433097755: 1.3120972814694163, 826.5665828089599: 7.94695465954125, 830.0568927789934: 13.129102844632756, 831.5448577680525: 4.3763676148399115, 836.6214442013129: 2.1881838071971296, 837.234135667396: 4.376367614845547, 837.8030634573304: 35.010940919002735, 841.8664541909187: 12.03028296382178, 846.3807439824946: 1.750547045586516, 848.4814004376367: 0.568927789934395, 849.5754923413567: 30.634573304125958, 854.5207877461706: 0.6564551422317848, 857.1903719912473: 1.3129102839767155, 859.1597374179431: 17.50547045950853, 863.4923413566739: 15.317286652068542, 865.469184130712: 29.20051773802159, 866.8621444201312: 4.376367614840063, 868.0: 5.689277899344474, 868.218818380744: 6.564551422319682, 870.4507658643327: 1.3129102839772355, 877.190371991244: 4.376367613743546, 878.1094091903724: 26.2582056879645, 878.4157549234137: 17.505470458778227, 883.1422319474835: 0.262582056892803, 885.4179431072209: 13.129102844635762, 886.5947874281137: 7.437997551100201, 891.9824945295405: 2.6258205687594547, 898.8971553610503: 0.8752735229757134, 908.0: 4.376367614838839, 914.9146608315099: 5.251641137834712, 920.2100656455142: 3.9387308533338343, 922.0688951698448: 3.3797527091026245, 927.6061269146609: 0.39387308533920273, 928.7877461706784: 8.752735229757006, 930.144420131291: 3.5010940918132034, 931.1072210065647: 0.35010940916879774, 931.4573304157549: 1.3129102844605525, 932.6827133479212: 3.0634573302989097, 937.3654266958424: 0.6564551422320757, 942.5733041575493: 2.188183807192464, 945.9431072210066: 1.3129102839781117, 948.7002188183808: 2.188183807191779, 953.4704595185996: 2.6258205687594476, 954.7833698030635: 1.3129102839777373, 957.7592997811817: 5.2516411378370345, 966.5995623632385: 7.877461706780519, 980.910284463895: 4.376367614839546}"}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"fullname": "ramanchada2.misc.constants.neon_wl_633_nist_dict", "modulename": "ramanchada2.misc.constants", "qualname": "neon_wl_633_nist_dict", "kind": "variable", "doc": "\n", "default_value": "{638.3287981859411: 5.6689342403499765, 640.2562358276643: 11.337868480727586, 650.6870748299319: 8.503401360545043, 653.3514739229025: 0.566893424036351, 659.9274376417234: 5.668934240348053, 665.2562358276643: 0.8503401360546983, 667.8639455782313: 2.8344671200402334, 671.7755102040816: 0.39682539682552465, 692.9773242630386: 56.68934240353873, 702.4444444444445: 17.006802721074873, 703.2947845804988: 45.351473922858105, 705.1655328798186: 1.1337868476493322, 705.9591836734694: 5.668934240348062, 717.4671201814059: 45.351473922836774, 721.3786848072563: 8.503401360545148, 723.5895691609977: 8.50340136054297, 724.5532879818594: 45.351473922833904, 734.4739229024943: 8.503401360542986, 747.2857142857143: 1.7006802717293952, 748.9297052154195: 17.00680272108454, 749.2698412698412: 5.6689342403646865, 752.3310657596371: 8.503401360527796, 753.6349206349206: 17.006802721048707, 754.4852607709751: 7.369614512457517, 772.5124716553288: 0.05668934240365808, 774.156462585034: 6.802721088429488, 783.9637188208617: 0.11337868480724644, 792.6951245635115: 6.971961625854252, 793.77097505694: 0.7369614305162637, 794.3945578231699: 4.535147381418968, 808.4417565814348: 9.329816961551543, 811.9115646254535: 2.2675736482945825, 812.9319727898597: 0.6802720427342306, 813.6689342404153: 9.63718817885658, 825.9704271162868: 1.6978631010464373, 826.5881899888147: 10.231887665802304, 830.1088435374149: 17.00680272107302, 831.5827664399093: 5.668934240348589, 836.6281179138335: 2.8344671202589966, 837.2517006802728: 5.6689342195710095, 837.8185941043079: 45.351473923298364, 841.8913979246645: 15.8101670633123, 846.3786848072561: 2.26757369591529, 848.4761904759695: 0.7369614416713715, 849.6099773242671: 39.68253967290885, 854.5419501133787: 0.8503401360543106, 857.2063492063492: 1.7006802717279004, 859.1904761904761: 22.67573696142483, 863.4988662131518: 19.841269841214043, 864.7460316744742: 3.401354571136033, 865.4928040619619: 38.396369552201875, 866.9002267573604: 5.668934237269633, 868.034013605442: 7.369614508413964, 868.26077097504: 8.503401360112813, 870.4716553287982: 1.7006802717287801, 877.2176870748299: 5.668934240361571, 878.1247165532881: 34.01360544219461, 878.4081632653063: 22.675736961434616, 883.1700680272108: 0.3401360544216929}"}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"fullname": "ramanchada2.misc.constants.neon_wl_532_nist_dict", "modulename": "ramanchada2.misc.constants", "qualname": "neon_wl_532_nist_dict", "kind": "variable", "doc": "\n", "default_value": "{540.0804670242978: 6.311139160610751, 556.3000946670874: 1.5777847897339283, 565.7036920164089: 1.5777847897345527, 571.9517197854212: 1.5777847897346757, 574.8548437993057: 1.5777847897345527, 576.4641842852635: 2.2088987059726164, 580.4717576522562: 1.5777847897345527, 582.0495424424108: 1.5777847897345523, 585.2682234143263: 6.311139160610822, 587.3193436415273: 1.5777847897341903, 588.234458819817: 3.1555695802011297, 590.285579047018: 0.15777847901546926, 590.6642473966551: 0.15777847901546949, 594.5140422846324: 1.5777847897344977, 596.5651625118334: 1.5777847897347166, 597.5336867539808: 3.5612432617200778, 598.837172609656: 0.4733354370464895, 603.0340801514673: 3.155569580200976, 607.4518775639002: 3.155569580201294, 609.6607762701167: 0.9466708739111769, 612.8794572420321: 0.31555695803092476, 614.3310192489744: 3.1555695802009724, 616.3821394761754: 3.1555695802010364, 618.2439255285578: 0.4733354370463865, 621.7466077627012: 3.1555695802013357, 626.6692963079836: 3.1555695802012638, 630.5190911959609: 0.31555695803092476, 632.8542126853799: 0.9466708729394551, 633.4853266014544: 3.1555695792292964, 638.3449037551278: 3.1555695802011074, 640.2698011991164: 6.31113916061083, 650.6831808141369: 4.733354370433662, 653.3338592615967: 0.3155569580309239, 659.928999684443: 3.155569580201134, 665.2303565793626: 0.4733354370463867, 667.8494793310192: 1.5777847897339252, 671.7308299147995: 0.22088987062164733}"}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"fullname": "ramanchada2.misc.constants.neon_wl_514_nist_dict", "modulename": "ramanchada2.misc.constants", "qualname": "neon_wl_514_nist_dict", "kind": "variable", "doc": "\n", "default_value": "{533.1227516566739: 1.893341747575223, 534.1325339224629: 3.155569580094588, 534.3534237930478: 1.893341747594008, 540.0965604291574: 6.311139160528673, 556.316188071947: 1.5777847894388257, 565.6882297254654: 1.5777847894388244, 571.9678131902808: 1.577784789438823, 574.8709372041653: 1.5777847894384802, 576.480277690123: 2.208898705700221, 580.4878510571158: 1.577784789439162, 582.0340801514673: 1.577784789438819, 585.2843168191858: 6.3111391605299945, 587.3038813505837: 1.5777847894388177, 588.2189965288734: 3.1555695799820027, 590.2701167560745: 0.15777847901555297, 590.6803408015146: 0.1577784790155361, 594.5301356894919: 1.577784789438816, 596.5812559166928: 1.577784789438815, 597.5497766401437: 3.5613026786141493, 598.8217103187125: 0.4733354370463101, 603.0186178605237: 3.155569579981991, 607.4679709687598: 3.1555695799819894, 609.6453139791731: 0.9466708736863838, 612.8639949510887: 0.3155569580308466, 614.347112653834: 3.155569579981985, 616.3982328810349: 3.155569579981983, 618.2600189334174: 0.47333543704630987, 621.7627011675606: 3.1555695799819796, 626.6853897128431: 3.1555695799819743, 630.5036289050173: 0.3155569580308466, 632.8387503944462: 0.9466708736863778, 633.469864310508: 3.15556957998197, 638.3294414641841: 3.1555695799826475, 640.2543389081728: 6.311139160528551}"}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"fullname": "ramanchada2.misc.constants.neon_rs_514_nist_dict", "modulename": "ramanchada2.misc.constants", "qualname": "neon_rs_514_nist_dict", "kind": "variable", "doc": "\n", "default_value": "{np.float64(939.4934887766555): np.float64(6.311139160610751), np.float64(1479.3436997493238): np.float64(1.5777847897339283), np.float64(1778.1542160402296): np.float64(1.5777847897345527), np.float64(1971.2596823698889): np.float64(1.5777847897346757), np.float64(2059.5571041787043): np.float64(1.5777847897345527), np.float64(2108.1214353517908): np.float64(2.2088987059726164), np.float64(2227.885922096006): np.float64(1.5777847897345527), np.float64(2274.584829386518): np.float64(1.5777847897345523), np.float64(2369.0698659052264): np.float64(6.311139160610822), np.float64(2428.7406668822714): np.float64(1.5777847897341903), np.float64(2455.228778146369): np.float64(3.1555695802011297), np.float64(2514.3003438672263): np.float64(0.15777847901546926), np.float64(2525.1610021530646): np.float64(0.15777847901546949), np.float64(2634.792359322113): np.float64(1.5777847897344977), np.float64(2692.6247455413572): np.float64(1.5777847897347166), np.float64(2719.79478148628): np.float64(3.5612432617200778), np.float64(2756.222768871403): np.float64(0.4733354370464895), np.float64(2872.442212982116): np.float64(3.155569580200976), np.float64(2993.043532906524): np.float64(3.155569580201294), np.float64(3052.68875600141): np.float64(0.9466708739111769), np.float64(3138.830689029075): np.float64(0.31555695803092476), np.float64(3177.383680584302): np.float64(3.1555695802009724), np.float64(3231.551159994985): np.float64(3.1555695802010364), np.float64(3280.4073806618967): np.float64(0.4733354370463865), np.float64(3371.5302648035954): np.float64(3.1555695802013357), np.float64(3497.873070711381): np.float64(3.1555695802012638), np.float64(3595.304917297004): np.float64(0.31555695803092476), np.float64(3653.825354794028): np.float64(0.9466708729394551), np.float64(3669.567630755911): np.float64(3.1555695792292964), np.float64(3789.740526516658): np.float64(3.1555695802011074), np.float64(3836.8370859752126): np.float64(6.31113916061083), np.float64(4086.7905162200564): np.float64(4.733354370433662), np.float64(4149.142790608222): np.float64(0.3155569580309239), np.float64(4302.107648445758): np.float64(3.155569580201134), np.float64(4422.86616519335): np.float64(0.4733354370463867), np.float64(4481.819069066493): np.float64(1.5777847897339252), np.float64(4568.337572645141): np.float64(0.22088987062164733)}"}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"fullname": "ramanchada2.misc.constants.neon_rs_532_nist_dict", "modulename": "ramanchada2.misc.constants", "qualname": "neon_rs_532_nist_dict", "kind": "variable", "doc": "\n", "default_value": "{np.float64(281.2330516917239): np.float64(6.311139160610751), np.float64(821.0832626643922): np.float64(1.5777847897339283), np.float64(1119.893778955298): np.float64(1.5777847897345527), np.float64(1312.9992452849574): np.float64(1.5777847897346757), np.float64(1401.2966670937728): np.float64(1.5777847897345527), np.float64(1449.8609982668593): np.float64(2.2088987059726164), np.float64(1569.6254850110745): np.float64(1.5777847897345527), np.float64(1616.3243923015864): np.float64(1.5777847897345523), np.float64(1710.8094288202951): np.float64(6.311139160610822), np.float64(1770.4802297973397): np.float64(1.5777847897341903), np.float64(1796.9683410614377): np.float64(3.1555695802011297), np.float64(1856.0399067822946): np.float64(0.15777847901546926), np.float64(1866.9005650681333): np.float64(0.15777847901546949), np.float64(1976.5319222371818): np.float64(1.5777847897344977), np.float64(2034.3643084564255): np.float64(1.5777847897347166), np.float64(2061.5343444013483): np.float64(3.5612432617200778), np.float64(2097.962331786471): np.float64(0.4733354370464895), np.float64(2214.1817758971847): np.float64(3.155569580200976), np.float64(2334.7830958215923): np.float64(3.155569580201294), np.float64(2394.428318916479): np.float64(0.9466708739111769), np.float64(2480.5702519441434): np.float64(0.31555695803092476), np.float64(2519.123243499371): np.float64(3.1555695802009724), np.float64(2573.290722910054): np.float64(3.1555695802010364), np.float64(2622.1469435769654): np.float64(0.4733354370463865), np.float64(2713.269827718664): np.float64(3.1555695802013357), np.float64(2839.6126336264497): np.float64(3.1555695802012638), np.float64(2937.0444802120724): np.float64(0.31555695803092476), np.float64(2995.564917709097): np.float64(0.9466708729394551), np.float64(3011.3071936709794): np.float64(3.1555695792292964), np.float64(3131.480089431727): np.float64(3.1555695802011074), np.float64(3178.576648890281): np.float64(6.31113916061083), np.float64(3428.5300791351247): np.float64(4.733354370433662), np.float64(3490.88235352329): np.float64(0.3155569580309239), np.float64(3643.8472113608263): np.float64(3.155569580201134), np.float64(3764.6057281084186): np.float64(0.4733354370463867), np.float64(3823.558631981562): np.float64(1.5777847897339252), np.float64(3910.0771355602096): np.float64(0.22088987062164733)}"}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"fullname": "ramanchada2.misc.constants.neon_rs_633_nist_dict", "modulename": "ramanchada2.misc.constants", "qualname": "neon_rs_633_nist_dict", "kind": "variable", "doc": "\n", "default_value": "{np.float64(131.88066389220208): np.float64(5.6689342403499765), np.float64(179.04156354222116): np.float64(11.337868480727586), np.float64(429.41787963591844): np.float64(8.503401360545043), np.float64(492.0908418445599): np.float64(0.566893424036351), np.float64(644.6071724264865): np.float64(5.668934240348053), np.float64(765.9863340283906): np.float64(0.8503401360546983), np.float64(824.6787920356078): np.float64(2.8344671200402334), np.float64(911.8631038159482): np.float64(0.39682539682552465), np.float64(1367.3016979214524): np.float64(56.68934240353873), np.float64(1561.7870442143164): np.float64(17.006802721074873), np.float64(1578.9995182981806): np.float64(45.351473922858105), np.float64(1616.7208386258383): np.float64(1.1337868476493322), np.float64(1632.6634252703236): np.float64(5.668934240348062), np.float64(1859.8673670412886): np.float64(45.351473922836774), np.float64(1935.4435930445873): np.float64(8.503401360545148), np.float64(1977.799152530638): np.float64(8.50340136054297), np.float64(1996.1809387646144): np.float64(45.351473922833904), np.float64(2182.601046783266): np.float64(8.503401360542986), np.float64(2416.025740338238): np.float64(1.7006802717293952), np.float64(2445.4003213358865): np.float64(17.00680272108454), np.float64(2451.46172714364): np.float64(5.6689342403646865), np.float64(2505.7677416665): np.float64(8.503401360527796), np.float64(2528.764109463943): np.float64(17.006802721048707), np.float64(2543.718919624388): np.float64(7.369614512457517), np.float64(2853.013478270963): np.float64(0.05668934240365808), np.float64(2880.502872777571): np.float64(6.802721088429488), np.float64(3042.0959734648623): np.float64(0.11337868480724644), np.float64(3182.5978156792344): np.float64(6.971961625854252), np.float64(3199.69602075866): np.float64(0.7369614305162637), np.float64(3209.585254214946): np.float64(4.535147381418968), np.float64(3428.313429608364): np.float64(9.329816961551543), np.float64(3481.175964530883): np.float64(2.2675736482945825), np.float64(3496.636018035287): np.float64(0.6802720427342306), np.float64(3507.7774966574075): np.float64(9.63718817885658), np.float64(3690.8173192671397): np.float64(1.6978631010464373), np.float64(3699.8656425642857): np.float64(10.231887665802304), np.float64(3751.175292738612): np.float64(17.00680272107302), np.float64(3772.5270806058697): np.float64(5.668934240348589), np.float64(3845.04636147525): np.float64(2.8344671202589966), np.float64(3853.948730839821): np.float64(5.6689342195710095), np.float64(3862.03029427443): np.float64(45.351473923298364), np.float64(3919.7717095729495): np.float64(15.8101670633123), np.float64(3982.7459657037134): np.float64(2.26757369591529), np.float64(4011.9537603014455): np.float64(0.7369614416713715), np.float64(4027.681711437721): np.float64(39.68253967290885), np.float64(4095.6126602455083): np.float64(0.8503401360543106), np.float64(4131.985776490957): np.float64(1.7006802717279004), np.float64(4158.925592793552): np.float64(22.67573696142483), np.float64(4216.997191919614): np.float64(19.841269841214043), np.float64(4233.699393684956): np.float64(3.401354571136033), np.float64(4243.677226254282): np.float64(38.396369552201875), np.float64(4262.435461241407): np.float64(5.668934237269633), np.float64(4277.502418460247): np.float64(7.369614508413964), np.float64(4280.511087990217): np.float64(8.503401360112813), np.float64(4309.7634684110535): np.float64(1.7006802717287801), np.float64(4398.109361819262): np.float64(5.668934240361571), np.float64(4409.8842779054585): np.float64(34.01360544219461), np.float64(4413.558952264782): np.float64(22.675736961434616), np.float64(4474.940806054933): np.float64(0.3401360544216929)}"}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"fullname": "ramanchada2.misc.constants.neon_rs_785_nist_dict", "modulename": "ramanchada2.misc.constants", "qualname": "neon_rs_785_nist_dict", "kind": "variable", "doc": "\n", "default_value": "{np.float64(123.48791116373066): np.float64(5.37437266023976), np.float64(140.15913593139325): np.float64(0.5689277951354417), np.float64(149.87670877344723): np.float64(3.501094091821991), np.float64(369.17670041748454): np.float64(7.202537154952434), np.float64(421.9893714023522): np.float64(1.7505470455873593), np.float64(437.9028038877788): np.float64(0.5251641209139684), np.float64(449.1499620289975): np.float64(7.439824945294173), np.float64(632.1231345393229): np.float64(1.3120972814694163), np.float64(640.6145857383626): np.float64(7.94695465954125), np.float64(691.4865250966848): np.float64(13.129102844632756), np.float64(713.0440635821694): np.float64(4.3763676148399115), np.float64(786.0162082399527): np.float64(2.1881838071971296), np.float64(794.7633449059146): np.float64(4.376367614845547), np.float64(802.8742305220228): np.float64(35.010940919002735), np.float64(860.4849683432024): np.float64(12.03028296382178), np.float64(923.8399042850345): np.float64(1.750547045586516), np.float64(953.0913228444969): np.float64(0.568927789934395), np.float64(968.2691464716178): np.float64(30.634573304125958), np.float64(1036.3880472238798): np.float64(0.6564551422317848), np.float64(1072.833530550081): np.float64(1.3129102839767155), np.float64(1099.5743744242316): np.float64(17.50547045950853), np.float64(1157.9748768745785): np.float64(15.317286652068542), np.float64(1184.4270910599143): np.float64(29.20051773802159), np.float64(1202.993892324344): np.float64(4.376367614840063), np.float64(1218.1161759957727): np.float64(5.689277899344474), np.float64(1221.0197632407637): np.float64(6.564551422319682), np.float64(1250.5529672316122): np.float64(1.3129102839772355), np.float64(1338.8195774819583): np.float64(4.376367613743546), np.float64(1350.7509554394137): np.float64(26.2582056879645), np.float64(1354.7225333663616): np.float64(17.505470458778227), np.float64(1415.6491106733881): np.float64(0.262582056892803), np.float64(1444.7521380071198): np.float64(13.129102844635762), np.float64(1459.7436530032244): np.float64(7.437997551100201), np.float64(1527.8711561888636): np.float64(2.6258205687594547), np.float64(1614.11032165422): np.float64(0.8752735229757134), np.float64(1725.6376441538746): np.float64(4.376367614838839), np.float64(1808.8723496292414): np.float64(5.251641137834712), np.float64(1871.7695912247377): np.float64(3.9387308533338343), np.float64(1893.6769091320486): np.float64(3.3797527091026245), np.float64(1958.415869313852): np.float64(0.39387308533920273), np.float64(1972.1309218099645): np.float64(8.752735229757006), np.float64(1987.834861812345): np.float64(3.5010940918132034), np.float64(1998.9518308621705): np.float64(0.35010940916879774), np.float64(2002.9886670182382): np.float64(1.3129102844605525), np.float64(2017.093726910536): np.float64(3.0634573302989097), np.float64(2070.6554715489538): np.float64(0.6564551422320757), np.float64(2129.599076084452): np.float64(2.188183807192464), np.float64(2167.393207461413): np.float64(1.3129102839781117), np.float64(2198.1159744687006): np.float64(2.188183807191779), np.float64(2250.851593771674): np.float64(2.6258205687594476), np.float64(2265.27350978513): np.float64(1.3129102839777373), np.float64(2297.8168019125974): np.float64(5.2516411378370345), np.float64(2393.3077473486487): np.float64(7.877461706780519), np.float64(2544.241255373098): np.float64(4.376367614839546)}"}, "ramanchada2.misc.constants.neon_wl_D3_3": {"fullname": "ramanchada2.misc.constants.neon_wl_D3_3", "modulename": "ramanchada2.misc.constants", "qualname": "neon_wl_D3_3", "kind": "variable", "doc": "\n", "default_value": "[533.07775, 540.05616, 556.27662, 565.66588, 571.92248, 574.82985, 576.44188, 580.44496, 580.44496, 582.01558, 585.24878, 587.28275, 588.1895, 590.24623, 594.4834, 596.5471, 598.79074, 602.99968, 607.43376, 609.6163, 612.84498, 614.30627, 616.35937, 618.2146, 621.72812, 626.64952, 630.47893, 633.44276, 638.29914, 640.2248, 650.65277, 653.28824, 659.89528, 667.82766, 671.7043, 692.94672, 702.405, 703.24128, 705.91079, 717.3938, 724.51665, 748.88712, 753.57739, 754.40439, 794.31805, 808.24576, 811.85495, 813.64061, 830.03248, 836.57464, 837.7607, 846.33569, 849.53591, 854.46952, 857.13535, 859.12583, 863.46472, 870.41122, 877.16575, 878.37539, 885.38669, 891.95007, 898.85564, 898.85564, 914.8672, 920.17588, 927.55191, 930.08532, 932.65072, 937.33079, 942.53797, 945.9211, 948.66825, 953.4164, 954.74052, 966.542]"}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"fullname": "ramanchada2.misc.constants.neon_wl_D3_3_dict", "modulename": "ramanchada2.misc.constants", "qualname": "neon_wl_D3_3_dict", "kind": "variable", "doc": "\n", "default_value": "{533.07775: 1, 540.05616: 1, 556.27662: 1, 565.66588: 1, 571.92248: 1, 574.82985: 1, 576.44188: 1, 580.44496: 1, 582.01558: 1, 585.24878: 1, 587.28275: 1, 588.1895: 1, 590.24623: 1, 594.4834: 1, 596.5471: 1, 598.79074: 1, 602.99968: 1, 607.43376: 1, 609.6163: 1, 612.84498: 1, 614.30627: 1, 616.35937: 1, 618.2146: 1, 621.72812: 1, 626.64952: 1, 630.47893: 1, 633.44276: 1, 638.29914: 1, 640.2248: 1, 650.65277: 1, 653.28824: 1, 659.89528: 1, 667.82766: 1, 671.7043: 1, 692.94672: 1, 702.405: 1, 703.24128: 1, 705.91079: 1, 717.3938: 1, 724.51665: 1, 748.88712: 1, 753.57739: 1, 754.40439: 1, 794.31805: 1, 808.24576: 1, 811.85495: 1, 813.64061: 1, 830.03248: 1, 836.57464: 1, 837.7607: 1, 846.33569: 1, 849.53591: 1, 854.46952: 1, 857.13535: 1, 859.12583: 1, 863.46472: 1, 870.41122: 1, 877.16575: 1, 878.37539: 1, 885.38669: 1, 891.95007: 1, 898.85564: 1, 914.8672: 1, 920.17588: 1, 927.55191: 1, 930.08532: 1, 932.65072: 1, 937.33079: 1, 942.53797: 1, 945.9211: 1, 948.66825: 1, 953.4164: 1, 954.74052: 1, 966.542: 1}"}, "ramanchada2.misc.constants.NEON_WL": {"fullname": "ramanchada2.misc.constants.NEON_WL", "modulename": "ramanchada2.misc.constants", "qualname": "NEON_WL", "kind": "variable", "doc": "\n", "annotation": ": Final", "default_value": "{785: {792.6841221569385: 5.37437266023976, 793.7330415754924: 0.5689277951354417, 794.3457330415755: 3.501094091821991, 808.4285595693893: 7.202537154952434, 811.8949671772428: 1.7505470455873593, 812.945295404814: 0.5251641209139684, 813.6892778993436: 7.439824945294173, 825.9868433097755: 1.3120972814694163, 826.5665828089599: 7.94695465954125, 830.0568927789934: 13.129102844632756, 831.5448577680525: 4.3763676148399115, 836.6214442013129: 2.1881838071971296, 837.234135667396: 4.376367614845547, 837.8030634573304: 35.010940919002735, 841.8664541909187: 12.03028296382178, 846.3807439824946: 1.750547045586516, 848.4814004376367: 0.568927789934395, 849.5754923413567: 30.634573304125958, 854.5207877461706: 0.6564551422317848, 857.1903719912473: 1.3129102839767155, 859.1597374179431: 17.50547045950853, 863.4923413566739: 15.317286652068542, 865.469184130712: 29.20051773802159, 866.8621444201312: 4.376367614840063, 868.0: 5.689277899344474, 868.218818380744: 6.564551422319682, 870.4507658643327: 1.3129102839772355, 877.190371991244: 4.376367613743546, 878.1094091903724: 26.2582056879645, 878.4157549234137: 17.505470458778227, 883.1422319474835: 0.262582056892803, 885.4179431072209: 13.129102844635762, 886.5947874281137: 7.437997551100201, 891.9824945295405: 2.6258205687594547, 898.8971553610503: 0.8752735229757134, 908.0: 4.376367614838839, 914.9146608315099: 5.251641137834712, 920.2100656455142: 3.9387308533338343, 922.0688951698448: 3.3797527091026245, 927.6061269146609: 0.39387308533920273, 928.7877461706784: 8.752735229757006, 930.144420131291: 3.5010940918132034, 931.1072210065647: 0.35010940916879774, 931.4573304157549: 1.3129102844605525, 932.6827133479212: 3.0634573302989097, 937.3654266958424: 0.6564551422320757, 942.5733041575493: 2.188183807192464, 945.9431072210066: 1.3129102839781117, 948.7002188183808: 2.188183807191779, 953.4704595185996: 2.6258205687594476, 954.7833698030635: 1.3129102839777373, 957.7592997811817: 5.2516411378370345, 966.5995623632385: 7.877461706780519, 980.910284463895: 4.376367614839546}, 633: {638.3287981859411: 5.6689342403499765, 640.2562358276643: 11.337868480727586, 650.6870748299319: 8.503401360545043, 653.3514739229025: 0.566893424036351, 659.9274376417234: 5.668934240348053, 665.2562358276643: 0.8503401360546983, 667.8639455782313: 2.8344671200402334, 671.7755102040816: 0.39682539682552465, 692.9773242630386: 56.68934240353873, 702.4444444444445: 17.006802721074873, 703.2947845804988: 45.351473922858105, 705.1655328798186: 1.1337868476493322, 705.9591836734694: 5.668934240348062, 717.4671201814059: 45.351473922836774, 721.3786848072563: 8.503401360545148, 723.5895691609977: 8.50340136054297, 724.5532879818594: 45.351473922833904, 734.4739229024943: 8.503401360542986, 747.2857142857143: 1.7006802717293952, 748.9297052154195: 17.00680272108454, 749.2698412698412: 5.6689342403646865, 752.3310657596371: 8.503401360527796, 753.6349206349206: 17.006802721048707, 754.4852607709751: 7.369614512457517, 772.5124716553288: 0.05668934240365808, 774.156462585034: 6.802721088429488, 783.9637188208617: 0.11337868480724644, 792.6951245635115: 6.971961625854252, 793.77097505694: 0.7369614305162637, 794.3945578231699: 4.535147381418968, 808.4417565814348: 9.329816961551543, 811.9115646254535: 2.2675736482945825, 812.9319727898597: 0.6802720427342306, 813.6689342404153: 9.63718817885658, 825.9704271162868: 1.6978631010464373, 826.5881899888147: 10.231887665802304, 830.1088435374149: 17.00680272107302, 831.5827664399093: 5.668934240348589, 836.6281179138335: 2.8344671202589966, 837.2517006802728: 5.6689342195710095, 837.8185941043079: 45.351473923298364, 841.8913979246645: 15.8101670633123, 846.3786848072561: 2.26757369591529, 848.4761904759695: 0.7369614416713715, 849.6099773242671: 39.68253967290885, 854.5419501133787: 0.8503401360543106, 857.2063492063492: 1.7006802717279004, 859.1904761904761: 22.67573696142483, 863.4988662131518: 19.841269841214043, 864.7460316744742: 3.401354571136033, 865.4928040619619: 38.396369552201875, 866.9002267573604: 5.668934237269633, 868.034013605442: 7.369614508413964, 868.26077097504: 8.503401360112813, 870.4716553287982: 1.7006802717287801, 877.2176870748299: 5.668934240361571, 878.1247165532881: 34.01360544219461, 878.4081632653063: 22.675736961434616, 883.1700680272108: 0.3401360544216929}, 532: {540.0804670242978: 6.311139160610751, 556.3000946670874: 1.5777847897339283, 565.7036920164089: 1.5777847897345527, 571.9517197854212: 1.5777847897346757, 574.8548437993057: 1.5777847897345527, 576.4641842852635: 2.2088987059726164, 580.4717576522562: 1.5777847897345527, 582.0495424424108: 1.5777847897345523, 585.2682234143263: 6.311139160610822, 587.3193436415273: 1.5777847897341903, 588.234458819817: 3.1555695802011297, 590.285579047018: 0.15777847901546926, 590.6642473966551: 0.15777847901546949, 594.5140422846324: 1.5777847897344977, 596.5651625118334: 1.5777847897347166, 597.5336867539808: 3.5612432617200778, 598.837172609656: 0.4733354370464895, 603.0340801514673: 3.155569580200976, 607.4518775639002: 3.155569580201294, 609.6607762701167: 0.9466708739111769, 612.8794572420321: 0.31555695803092476, 614.3310192489744: 3.1555695802009724, 616.3821394761754: 3.1555695802010364, 618.2439255285578: 0.4733354370463865, 621.7466077627012: 3.1555695802013357, 626.6692963079836: 3.1555695802012638, 630.5190911959609: 0.31555695803092476, 632.8542126853799: 0.9466708729394551, 633.4853266014544: 3.1555695792292964, 638.3449037551278: 3.1555695802011074, 640.2698011991164: 6.31113916061083, 650.6831808141369: 4.733354370433662, 653.3338592615967: 0.3155569580309239, 659.928999684443: 3.155569580201134, 665.2303565793626: 0.4733354370463867, 667.8494793310192: 1.5777847897339252, 671.7308299147995: 0.22088987062164733}, 514: {540.0804670242978: 6.311139160610751, 556.3000946670874: 1.5777847897339283, 565.7036920164089: 1.5777847897345527, 571.9517197854212: 1.5777847897346757, 574.8548437993057: 1.5777847897345527, 576.4641842852635: 2.2088987059726164, 580.4717576522562: 1.5777847897345527, 582.0495424424108: 1.5777847897345523, 585.2682234143263: 6.311139160610822, 587.3193436415273: 1.5777847897341903, 588.234458819817: 3.1555695802011297, 590.285579047018: 0.15777847901546926, 590.6642473966551: 0.15777847901546949, 594.5140422846324: 1.5777847897344977, 596.5651625118334: 1.5777847897347166, 597.5336867539808: 3.5612432617200778, 598.837172609656: 0.4733354370464895, 603.0340801514673: 3.155569580200976, 607.4518775639002: 3.155569580201294, 609.6607762701167: 0.9466708739111769, 612.8794572420321: 0.31555695803092476, 614.3310192489744: 3.1555695802009724, 616.3821394761754: 3.1555695802010364, 618.2439255285578: 0.4733354370463865, 621.7466077627012: 3.1555695802013357, 626.6692963079836: 3.1555695802012638, 630.5190911959609: 0.31555695803092476, 632.8542126853799: 0.9466708729394551, 633.4853266014544: 3.1555695792292964, 638.3449037551278: 3.1555695802011074, 640.2698011991164: 6.31113916061083, 650.6831808141369: 4.733354370433662, 653.3338592615967: 0.3155569580309239, 659.928999684443: 3.155569580201134, 665.2303565793626: 0.4733354370463867, 667.8494793310192: 1.5777847897339252, 671.7308299147995: 0.22088987062164733}}"}, "ramanchada2.misc.exceptions": {"fullname": "ramanchada2.misc.exceptions", "modulename": "ramanchada2.misc.exceptions", "kind": "module", "doc": "\n"}, "ramanchada2.misc.exceptions.ApplicationException": {"fullname": "ramanchada2.misc.exceptions.ApplicationException", "modulename": "ramanchada2.misc.exceptions", "qualname": "ApplicationException", "kind": "class", "doc": "Common base class for all non-exit exceptions.
\n", "bases": "builtins.Exception"}, "ramanchada2.misc.exceptions.InputParserError": {"fullname": "ramanchada2.misc.exceptions.InputParserError", "modulename": "ramanchada2.misc.exceptions", "qualname": "InputParserError", "kind": "class", "doc": "Common base class for all non-exit exceptions.
\n", "bases": "ApplicationException"}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"fullname": "ramanchada2.misc.exceptions.ChadaReadNotFoundError", "modulename": "ramanchada2.misc.exceptions", "qualname": "ChadaReadNotFoundError", "kind": "class", "doc": "Common base class for all non-exit exceptions.
\n", "bases": "ApplicationException"}, "ramanchada2.misc.plottable": {"fullname": "ramanchada2.misc.plottable", "modulename": "ramanchada2.misc.plottable", "kind": "module", "doc": "\n"}, "ramanchada2.misc.plottable.Plottable": {"fullname": "ramanchada2.misc.plottable.Plottable", "modulename": "ramanchada2.misc.plottable", "qualname": "Plottable", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "abc.ABC"}, "ramanchada2.misc.plottable.Plottable.plot": {"fullname": "ramanchada2.misc.plottable.Plottable.plot", "modulename": "ramanchada2.misc.plottable", "qualname": "Plottable.plot", "kind": "function", "doc": "\n", "signature": "(self, ax=None, label=' ', **kwargs) -> matplotlib.axes._axes.Axes:", "funcdef": "def"}, "ramanchada2.misc.spectrum_deco": {"fullname": "ramanchada2.misc.spectrum_deco", "modulename": "ramanchada2.misc.spectrum_deco", "kind": "module", "doc": "\n"}, "ramanchada2.misc.spectrum_deco.dynamically_added": {"fullname": "ramanchada2.misc.spectrum_deco.dynamically_added", "modulename": "ramanchada2.misc.spectrum_deco.dynamically_added", "kind": "module", "doc": "\n"}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"fullname": "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters", "modulename": "ramanchada2.misc.spectrum_deco.dynamically_added", "qualname": "dynamically_added_filters", "kind": "variable", "doc": "\n", "annotation": ": Set[str]", "default_value": "{'convolve', 'set_new_xaxis', 'add_poisson_noise', 'scale_xaxis_linear', 'subtract_baseline_rc1_snip', 'dropna', 'moving_average', 'xcal_fine', '__mul__', 'hht_sharpening', 'trim_axes', 'xcal_argmin2d_iter_lowpass', 'resample_NUDFT_filter', 'moving_minimum', 'shift_cm_1_to_abs_nm_filter', 'subtract_baseline_rc1_als', 'xcal_fine_RBF', 'moving_median', 'add_baseline', 'drop_spikes', 'derivative_sharpening', 'normalize', 'subtract_moving_minimum', 'hht_sharpening_chain', 'resample_spline_filter', 'add_gaussian_noise', 'add_gaussian_noise_drift', 'subtract_moving_median', 'abs_nm_to_shift_cm_1_filter', 'recover_spikes', 'scale_yaxis_linear', 'smoothing_RC1', '__truediv__', 'get_spikes', 'fit_peaks_filter', '__sub__', 'calibrate_by_deltas_filter', 'scale_xaxis_fun', 'moving_average_convolve', '__add__', 'find_peak_multipeak_filter', 'pad_zeros'}"}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"fullname": "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors", "modulename": "ramanchada2.misc.spectrum_deco.dynamically_added", "qualname": "dynamically_added_constructors", "kind": "variable", "doc": "\n", "annotation": ": Set[str]", "default_value": "{'from_test_spe', 'from_stream', 'hdr_from_multi_exposure', 'from_simulation', 'from_chada', 'from_delta_lines', 'from_theoretical_lines', 'from_local_file', 'from_spectral_component_collection', 'from_cache_or_calc'}"}, "ramanchada2.misc.spectrum_deco.spectrum_constructor": {"fullname": "ramanchada2.misc.spectrum_deco.spectrum_constructor", "modulename": "ramanchada2.misc.spectrum_deco.spectrum_constructor", "kind": "module", "doc": "\n"}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"fullname": "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor", "modulename": "ramanchada2.misc.spectrum_deco.spectrum_constructor", "qualname": "add_spectrum_constructor", "kind": "class", "doc": "\n"}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"fullname": "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__", "modulename": "ramanchada2.misc.spectrum_deco.spectrum_constructor", "qualname": "add_spectrum_constructor.__init__", "kind": "function", "doc": "\n", "signature": "(set_applied_processing=True)"}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"fullname": "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc", "modulename": "ramanchada2.misc.spectrum_deco.spectrum_constructor", "qualname": "add_spectrum_constructor.set_proc", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.spectrum_deco.spectrum_filter": {"fullname": "ramanchada2.misc.spectrum_deco.spectrum_filter", "modulename": "ramanchada2.misc.spectrum_deco.spectrum_filter", "kind": "module", "doc": "\n"}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"fullname": "ramanchada2.misc.spectrum_deco.spectrum_filter.logger", "modulename": "ramanchada2.misc.spectrum_deco.spectrum_filter", "qualname": "logger", "kind": "variable", "doc": "\n", "default_value": "<Logger ramanchada2.misc.spectrum_deco.spectrum_filter (WARNING)>"}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"fullname": "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter", "modulename": "ramanchada2.misc.spectrum_deco.spectrum_filter", "qualname": "add_spectrum_filter", "kind": "function", "doc": "\n", "signature": "(fun):", "funcdef": "def"}, "ramanchada2.misc.spectrum_deco.spectrum_method": {"fullname": "ramanchada2.misc.spectrum_deco.spectrum_method", "modulename": "ramanchada2.misc.spectrum_deco.spectrum_method", "kind": "module", "doc": "\n"}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"fullname": "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method", "modulename": "ramanchada2.misc.spectrum_deco.spectrum_method", "qualname": "add_spectrum_method", "kind": "function", "doc": "\n", "signature": "(fun):", "funcdef": "def"}, "ramanchada2.misc.types": {"fullname": "ramanchada2.misc.types", "modulename": "ramanchada2.misc.types", "kind": "module", "doc": "\n"}, "ramanchada2.misc.types.fit_peaks_result": {"fullname": "ramanchada2.misc.types.fit_peaks_result", "modulename": "ramanchada2.misc.types.fit_peaks_result", "kind": "module", "doc": "\n"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult", "kind": "class", "doc": "A more or less complete user-defined wrapper around list objects.
\n", "bases": "collections.UserList, ramanchada2.misc.plottable.Plottable"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.valuesdict", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.locations", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.centers", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.fwhm", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.boundaries", "kind": "function", "doc": "\n", "signature": "(self, n_sigma=5):", "funcdef": "def"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.center_amplitude", "kind": "function", "doc": "\n", "signature": "(self, threshold):", "funcdef": "def"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.centers_err", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.fwhms", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.amplitudes", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.dumps", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.loads", "kind": "function", "doc": "\n", "signature": "(cls, json_str: List[str]):", "funcdef": "def"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.to_dataframe", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.to_dataframe_peaks", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.to_csv", "kind": "function", "doc": "\n", "signature": "(self, path_or_buf=None, sep=',', **kwargs):", "funcdef": "def"}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"fullname": "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum", "modulename": "ramanchada2.misc.types.fit_peaks_result", "qualname": "FitPeaksResult.gen_fake_spectrum", "kind": "function", "doc": "\n", "signature": "(self, xarr):", "funcdef": "def"}, "ramanchada2.misc.types.peak_candidates": {"fullname": "ramanchada2.misc.types.peak_candidates", "modulename": "ramanchada2.misc.types.peak_candidates", "kind": "module", "doc": "\n"}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/
\n\nA base class for creating Pydantic models.
\n\nAttributes:
\n\n\n- __class_vars__: The names of the class variables defined on the model.
\n- __private_attributes__: Metadata about the private attributes of the model.
\n- __signature__: The synthesized
__init__
[Signature
][inspect.Signature] of the model. \n- __pydantic_complete__: Whether model building is completed, or if there are still undefined fields.
\n- __pydantic_core_schema__: The core schema of the model.
\n- __pydantic_custom_init__: Whether the model has a custom
__init__
function. \n- __pydantic_decorators__: Metadata containing the decorators defined on the model.\nThis replaces
Model.__validators__
and Model.__root_validators__
from Pydantic V1. \n- __pydantic_generic_metadata__: Metadata for generic models; contains data used for a similar purpose to\n__args__, __origin__, __parameters__ in typing-module generics. May eventually be replaced by these.
\n- __pydantic_parent_namespace__: Parent namespace of the model, used for automatic rebuilding of models.
\n- __pydantic_post_init__: The name of the post-init method for the model, if defined.
\n- __pydantic_root_model__: Whether the model is a [
RootModel
][pydantic.root_model.RootModel]. \n- __pydantic_serializer__: The
pydantic-core
SchemaSerializer
used to dump instances of the model. \n- __pydantic_validator__: The
pydantic-core
SchemaValidator
used to validate instances of the model. \n- __pydantic_extra__: A dictionary containing extra values, if [
extra
][pydantic.config.ConfigDict.extra]\nis set to 'allow'
. \n- __pydantic_fields_set__: The names of fields explicitly set during instantiation.
\n- __pydantic_private__: Values of private attributes set on the model instance.
\n
\n", "bases": "ramanchada2.misc.types.pydantic_base_model.PydBaseModel"}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel.amplitude", "kind": "variable", "doc": "\n", "annotation": ": typing.Annotated[float, Gt(gt=0)]"}, "ramanchada2.misc.types.peak_candidates.PeakModel.position": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel.position", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel.position", "kind": "variable", "doc": "\n", "annotation": ": float"}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel.sigma", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel.sigma", "kind": "variable", "doc": "\n", "annotation": ": typing.Annotated[float, Gt(gt=0)]"}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel.skew", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel.skew", "kind": "variable", "doc": "\n", "annotation": ": float"}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel.fwhm", "kind": "variable", "doc": "\n", "annotation": ": float"}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel.lwhm", "kind": "variable", "doc": "Left width at half maximum.
\n", "annotation": ": float"}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel.rwhm", "kind": "variable", "doc": "Right width at half maximum.
\n", "annotation": ": float"}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel.serialize", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel.serialize", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel.model_config", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel.model_config", "kind": "variable", "doc": "Configuration for the model, should be a dictionary conforming to [ConfigDict
][pydantic.config.ConfigDict].
\n", "default_value": "{'arbitrary_types_allowed': True}"}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel.model_fields", "kind": "variable", "doc": "Metadata about the fields defined on the model,\nmapping of field names to [FieldInfo
][pydantic.fields.FieldInfo] objects.
\n\nThis replaces Model.__fields__
from Pydantic V1.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.FieldInfo]]", "default_value": "{'amplitude': FieldInfo(annotation=float, required=True, metadata=[Gt(gt=0)]), 'position': FieldInfo(annotation=float, required=True), 'sigma': FieldInfo(annotation=float, required=True, metadata=[Gt(gt=0)]), 'skew': FieldInfo(annotation=float, required=False, default=0)}"}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakModel.model_computed_fields", "kind": "variable", "doc": "A dictionary of computed field names and their corresponding ComputedFieldInfo
objects.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.ComputedFieldInfo]]", "default_value": "{}"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/
\n\nA base class for creating Pydantic models.
\n\nAttributes:
\n\n\n- __class_vars__: The names of the class variables defined on the model.
\n- __private_attributes__: Metadata about the private attributes of the model.
\n- __signature__: The synthesized
__init__
[Signature
][inspect.Signature] of the model. \n- __pydantic_complete__: Whether model building is completed, or if there are still undefined fields.
\n- __pydantic_core_schema__: The core schema of the model.
\n- __pydantic_custom_init__: Whether the model has a custom
__init__
function. \n- __pydantic_decorators__: Metadata containing the decorators defined on the model.\nThis replaces
Model.__validators__
and Model.__root_validators__
from Pydantic V1. \n- __pydantic_generic_metadata__: Metadata for generic models; contains data used for a similar purpose to\n__args__, __origin__, __parameters__ in typing-module generics. May eventually be replaced by these.
\n- __pydantic_parent_namespace__: Parent namespace of the model, used for automatic rebuilding of models.
\n- __pydantic_post_init__: The name of the post-init method for the model, if defined.
\n- __pydantic_root_model__: Whether the model is a [
RootModel
][pydantic.root_model.RootModel]. \n- __pydantic_serializer__: The
pydantic-core
SchemaSerializer
used to dump instances of the model. \n- __pydantic_validator__: The
pydantic-core
SchemaValidator
used to validate instances of the model. \n- __pydantic_extra__: A dictionary containing extra values, if [
extra
][pydantic.config.ConfigDict.extra]\nis set to 'allow'
. \n- __pydantic_fields_set__: The names of fields explicitly set during instantiation.
\n- __pydantic_private__: Values of private attributes set on the model instance.
\n
\n", "bases": "ramanchada2.misc.types.pydantic_base_model.PydBaseModel, ramanchada2.misc.plottable.Plottable"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.peaks", "kind": "variable", "doc": "\n", "annotation": ": List[ramanchada2.misc.types.peak_candidates.PeakModel]"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.base_slope", "kind": "variable", "doc": "\n", "annotation": ": float"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.base_intercept", "kind": "variable", "doc": "\n", "annotation": ": float"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.boundaries", "kind": "variable", "doc": "\n", "annotation": ": Tuple[float, float]"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.plot_params_baseline", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.plot_params_errorbar", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.positions", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.sigmas", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.fwhms", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.lwhms", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.rwhms", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.skews", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.amplitudes", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.bases", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.get_pos_ampl_dict", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.get_ampl_pos_fwhm", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.peak_bases", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.serialize", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.model_config", "kind": "variable", "doc": "Configuration for the model, should be a dictionary conforming to [ConfigDict
][pydantic.config.ConfigDict].
\n", "default_value": "{'arbitrary_types_allowed': True}"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.model_fields", "kind": "variable", "doc": "Metadata about the fields defined on the model,\nmapping of field names to [FieldInfo
][pydantic.fields.FieldInfo] objects.
\n\nThis replaces Model.__fields__
from Pydantic V1.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.FieldInfo]]", "default_value": "{'peaks': FieldInfo(annotation=List[PeakModel], required=True), 'base_slope': FieldInfo(annotation=float, required=False, default=0), 'base_intercept': FieldInfo(annotation=float, required=False, default=0), 'boundaries': FieldInfo(annotation=Tuple[float, float], required=True)}"}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"fullname": "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "PeakCandidateMultiModel.model_computed_fields", "kind": "variable", "doc": "A dictionary of computed field names and their corresponding ComputedFieldInfo
objects.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.ComputedFieldInfo]]", "default_value": "{}"}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"fullname": "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "ListPeakCandidateMultiModel", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/#rootmodel-and-custom-root-types
\n\nA Pydantic BaseModel
for the root object of the model.
\n\nAttributes:
\n\n\n- root: The root object of the model.
\n- __pydantic_root_model__: Whether the model is a RootModel.
\n- __pydantic_private__: Private fields in the model.
\n- __pydantic_extra__: Extra fields in the model.
\n
\n", "bases": "pydantic.main.BaseModel, typing.Generic[~RootModelRootType]"}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"fullname": "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "ListPeakCandidateMultiModel.root", "kind": "variable", "doc": "\n", "annotation": ": List[ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel]"}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"fullname": "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "ListPeakCandidateMultiModel.get_ampl_pos_fwhm", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"fullname": "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "ListPeakCandidateMultiModel.get_pos_ampl_dict", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"fullname": "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize", "modulename": "ramanchada2.misc.types.peak_candidates", "qualname": "ListPeakCandidateMultiModel.serialize", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.positive_not_multiple": {"fullname": "ramanchada2.misc.types.positive_not_multiple", "modulename": "ramanchada2.misc.types.positive_not_multiple", "kind": "module", "doc": "\n"}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"fullname": "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt", "modulename": "ramanchada2.misc.types.positive_not_multiple", "qualname": "PositiveOddInt", "kind": "variable", "doc": "\n", "default_value": "typing.Annotated[int, Gt(gt=0)]"}, "ramanchada2.misc.types.pydantic_base_model": {"fullname": "ramanchada2.misc.types.pydantic_base_model", "modulename": "ramanchada2.misc.types.pydantic_base_model", "kind": "module", "doc": "\n"}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"fullname": "ramanchada2.misc.types.pydantic_base_model.PydBaseModel", "modulename": "ramanchada2.misc.types.pydantic_base_model", "qualname": "PydBaseModel", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/
\n\nA base class for creating Pydantic models.
\n\nAttributes:
\n\n\n- __class_vars__: The names of the class variables defined on the model.
\n- __private_attributes__: Metadata about the private attributes of the model.
\n- __signature__: The synthesized
__init__
[Signature
][inspect.Signature] of the model. \n- __pydantic_complete__: Whether model building is completed, or if there are still undefined fields.
\n- __pydantic_core_schema__: The core schema of the model.
\n- __pydantic_custom_init__: Whether the model has a custom
__init__
function. \n- __pydantic_decorators__: Metadata containing the decorators defined on the model.\nThis replaces
Model.__validators__
and Model.__root_validators__
from Pydantic V1. \n- __pydantic_generic_metadata__: Metadata for generic models; contains data used for a similar purpose to\n__args__, __origin__, __parameters__ in typing-module generics. May eventually be replaced by these.
\n- __pydantic_parent_namespace__: Parent namespace of the model, used for automatic rebuilding of models.
\n- __pydantic_post_init__: The name of the post-init method for the model, if defined.
\n- __pydantic_root_model__: Whether the model is a [
RootModel
][pydantic.root_model.RootModel]. \n- __pydantic_serializer__: The
pydantic-core
SchemaSerializer
used to dump instances of the model. \n- __pydantic_validator__: The
pydantic-core
SchemaValidator
used to validate instances of the model. \n- __pydantic_extra__: A dictionary containing extra values, if [
extra
][pydantic.config.ConfigDict.extra]\nis set to 'allow'
. \n- __pydantic_fields_set__: The names of fields explicitly set during instantiation.
\n- __pydantic_private__: Values of private attributes set on the model instance.
\n
\n", "bases": "pydantic.main.BaseModel, abc.ABC"}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"fullname": "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config", "modulename": "ramanchada2.misc.types.pydantic_base_model", "qualname": "PydBaseModel.model_config", "kind": "variable", "doc": "Configuration for the model, should be a dictionary conforming to [ConfigDict
][pydantic.config.ConfigDict].
\n", "default_value": "{'arbitrary_types_allowed': True}"}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"fullname": "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize", "modulename": "ramanchada2.misc.types.pydantic_base_model", "qualname": "PydBaseModel.serialize", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"fullname": "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields", "modulename": "ramanchada2.misc.types.pydantic_base_model", "qualname": "PydBaseModel.model_fields", "kind": "variable", "doc": "Metadata about the fields defined on the model,\nmapping of field names to [FieldInfo
][pydantic.fields.FieldInfo] objects.
\n\nThis replaces Model.__fields__
from Pydantic V1.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.FieldInfo]]", "default_value": "{}"}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"fullname": "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields", "modulename": "ramanchada2.misc.types.pydantic_base_model", "qualname": "PydBaseModel.model_computed_fields", "kind": "variable", "doc": "A dictionary of computed field names and their corresponding ComputedFieldInfo
objects.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.ComputedFieldInfo]]", "default_value": "{}"}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"fullname": "ramanchada2.misc.types.pydantic_base_model.PydRootModel", "modulename": "ramanchada2.misc.types.pydantic_base_model", "qualname": "PydRootModel", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/#rootmodel-and-custom-root-types
\n\nA Pydantic BaseModel
for the root object of the model.
\n\nAttributes:
\n\n\n- root: The root object of the model.
\n- __pydantic_root_model__: Whether the model is a RootModel.
\n- __pydantic_private__: Private fields in the model.
\n- __pydantic_extra__: Extra fields in the model.
\n
\n", "bases": "pydantic.main.BaseModel, typing.Generic[~RootModelRootType]"}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"fullname": "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize", "modulename": "ramanchada2.misc.types.pydantic_base_model", "qualname": "PydRootModel.serialize", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum": {"fullname": "ramanchada2.misc.types.spectrum", "modulename": "ramanchada2.misc.types.spectrum", "kind": "module", "doc": "\n"}, "ramanchada2.misc.types.spectrum.applied_processings": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "kind": "module", "doc": "\n"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingModel", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/
\n\nA base class for creating Pydantic models.
\n\nAttributes:
\n\n\n- __class_vars__: The names of the class variables defined on the model.
\n- __private_attributes__: Metadata about the private attributes of the model.
\n- __signature__: The synthesized
__init__
[Signature
][inspect.Signature] of the model. \n- __pydantic_complete__: Whether model building is completed, or if there are still undefined fields.
\n- __pydantic_core_schema__: The core schema of the model.
\n- __pydantic_custom_init__: Whether the model has a custom
__init__
function. \n- __pydantic_decorators__: Metadata containing the decorators defined on the model.\nThis replaces
Model.__validators__
and Model.__root_validators__
from Pydantic V1. \n- __pydantic_generic_metadata__: Metadata for generic models; contains data used for a similar purpose to\n__args__, __origin__, __parameters__ in typing-module generics. May eventually be replaced by these.
\n- __pydantic_parent_namespace__: Parent namespace of the model, used for automatic rebuilding of models.
\n- __pydantic_post_init__: The name of the post-init method for the model, if defined.
\n- __pydantic_root_model__: Whether the model is a [
RootModel
][pydantic.root_model.RootModel]. \n- __pydantic_serializer__: The
pydantic-core
SchemaSerializer
used to dump instances of the model. \n- __pydantic_validator__: The
pydantic-core
SchemaValidator
used to validate instances of the model. \n- __pydantic_extra__: A dictionary containing extra values, if [
extra
][pydantic.config.ConfigDict.extra]\nis set to 'allow'
. \n- __pydantic_fields_set__: The names of fields explicitly set during instantiation.
\n- __pydantic_private__: Values of private attributes set on the model instance.
\n
\n", "bases": "pydantic.main.BaseModel"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingModel.proc", "kind": "variable", "doc": "\n", "annotation": ": str"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingModel.args", "kind": "variable", "doc": "\n", "annotation": ": List"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingModel.kwargs", "kind": "variable", "doc": "\n", "annotation": ": Dict"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingModel.is_constructor", "kind": "variable", "doc": "\n"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingModel.check_proc", "kind": "function", "doc": "\n", "signature": "(cls, val: str):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingModel.model_config", "kind": "variable", "doc": "Configuration for the model, should be a dictionary conforming to [ConfigDict
][pydantic.config.ConfigDict].
\n", "annotation": ": ClassVar[pydantic.config.ConfigDict]", "default_value": "{}"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingModel.model_fields", "kind": "variable", "doc": "Metadata about the fields defined on the model,\nmapping of field names to [FieldInfo
][pydantic.fields.FieldInfo] objects.
\n\nThis replaces Model.__fields__
from Pydantic V1.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.FieldInfo]]", "default_value": "{'proc': FieldInfo(annotation=str, required=True), 'args': FieldInfo(annotation=List, required=False, default=[]), 'kwargs': FieldInfo(annotation=Dict, required=False, default={})}"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingModel.model_computed_fields", "kind": "variable", "doc": "A dictionary of computed field names and their corresponding ComputedFieldInfo
objects.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.ComputedFieldInfo]]", "default_value": "{}"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingListModel", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/#rootmodel-and-custom-root-types
\n\nA Pydantic BaseModel
for the root object of the model.
\n\nAttributes:
\n\n\n- root: The root object of the model.
\n- __pydantic_root_model__: Whether the model is a RootModel.
\n- __pydantic_private__: Private fields in the model.
\n- __pydantic_extra__: Extra fields in the model.
\n
\n", "bases": "pydantic.main.BaseModel, typing.Generic[~RootModelRootType]"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingListModel.root", "kind": "variable", "doc": "\n", "annotation": ": List[ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel]"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingListModel.append", "kind": "function", "doc": "\n", "signature": "(self, proc, args=[], kwargs={}):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingListModel.extend_left", "kind": "function", "doc": "\n", "signature": "(\tself,\tproc_list: List[ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel]):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingListModel.pop", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingListModel.clear", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingListModel.assign", "kind": "function", "doc": "\n", "signature": "(self, *args, **kwargs):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingListModel.repr", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingListModel.cache_path", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"fullname": "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list", "modulename": "ramanchada2.misc.types.spectrum.applied_processings", "qualname": "SpeProcessingListModel.to_list", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.metadata": {"fullname": "ramanchada2.misc.types.spectrum.metadata", "modulename": "ramanchada2.misc.types.spectrum.metadata", "kind": "module", "doc": "\n"}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"fullname": "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping", "modulename": "ramanchada2.misc.types.spectrum.metadata", "qualname": "SpeMetadataFieldTyping", "kind": "variable", "doc": "\n", "default_value": "typing.Union[numpy.ndarray[typing.Any, numpy.dtype[+_ScalarType_co]], typing.Annotated[bool, Strict(strict=True)], typing.Annotated[int, Strict(strict=True)], float, datetime.datetime, typing.List[typing.Any], typing.Dict[str, typing.Any], typing.Annotated[str, Strict(strict=True)], NoneType]"}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"fullname": "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel", "modulename": "ramanchada2.misc.types.spectrum.metadata", "qualname": "SpeMetadataFieldModel", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/#rootmodel-and-custom-root-types
\n\nA Pydantic BaseModel
for the root object of the model.
\n\nAttributes:
\n\n\n- root: The root object of the model.
\n- __pydantic_root_model__: Whether the model is a RootModel.
\n- __pydantic_private__: Private fields in the model.
\n- __pydantic_extra__: Extra fields in the model.
\n
\n", "bases": "pydantic.main.BaseModel, typing.Generic[~RootModelRootType]"}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"fullname": "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root", "modulename": "ramanchada2.misc.types.spectrum.metadata", "qualname": "SpeMetadataFieldModel.root", "kind": "variable", "doc": "\n", "annotation": ": Union[numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], Annotated[bool, Strict(strict=True)], Annotated[int, Strict(strict=True)], float, datetime.datetime, List[Any], Dict[str, Any], Annotated[str, Strict(strict=True)], NoneType]"}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"fullname": "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate", "modulename": "ramanchada2.misc.types.spectrum.metadata", "qualname": "SpeMetadataFieldModel.pre_validate", "kind": "function", "doc": "\n", "signature": "(cls, val):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"fullname": "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize", "modulename": "ramanchada2.misc.types.spectrum.metadata", "qualname": "SpeMetadataFieldModel.serialize", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"fullname": "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel", "modulename": "ramanchada2.misc.types.spectrum.metadata", "qualname": "SpeMetadataModel", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/#rootmodel-and-custom-root-types
\n\nA Pydantic BaseModel
for the root object of the model.
\n\nAttributes:
\n\n\n- root: The root object of the model.
\n- __pydantic_root_model__: Whether the model is a RootModel.
\n- __pydantic_private__: Private fields in the model.
\n- __pydantic_extra__: Extra fields in the model.
\n
\n", "bases": "pydantic.main.BaseModel, typing.Generic[~RootModelRootType]"}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"fullname": "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root", "modulename": "ramanchada2.misc.types.spectrum.metadata", "qualname": "SpeMetadataModel.root", "kind": "variable", "doc": "\n", "annotation": ": Dict[str, ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel]"}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"fullname": "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate", "modulename": "ramanchada2.misc.types.spectrum.metadata", "qualname": "SpeMetadataModel.pre_validate", "kind": "function", "doc": "\n", "signature": "(cls, val):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"fullname": "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize", "modulename": "ramanchada2.misc.types.spectrum.metadata", "qualname": "SpeMetadataModel.serialize", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"fullname": "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys", "modulename": "ramanchada2.misc.types.spectrum.metadata", "qualname": "SpeMetadataModel.get_all_keys", "kind": "function", "doc": "Returns a list of all keys in the metadata model.
\n", "signature": "(self) -> list[str]:", "funcdef": "def"}, "ramanchada2.misc.utils": {"fullname": "ramanchada2.misc.utils", "modulename": "ramanchada2.misc.utils", "kind": "module", "doc": "\n"}, "ramanchada2.misc.utils.argmin2d": {"fullname": "ramanchada2.misc.utils.argmin2d", "modulename": "ramanchada2.misc.utils.argmin2d", "kind": "module", "doc": "\n"}, "ramanchada2.misc.utils.argmin2d.argmin2d": {"fullname": "ramanchada2.misc.utils.argmin2d.argmin2d", "modulename": "ramanchada2.misc.utils.argmin2d", "qualname": "argmin2d", "kind": "function", "doc": "\n", "signature": "(A, median_limit: Optional[float] = None):", "funcdef": "def"}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"fullname": "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx", "modulename": "ramanchada2.misc.utils.argmin2d", "qualname": "find_closest_pairs_idx", "kind": "function", "doc": "\n", "signature": "(x, y, **kw_args):", "funcdef": "def"}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"fullname": "ramanchada2.misc.utils.argmin2d.find_closest_pairs", "modulename": "ramanchada2.misc.utils.argmin2d", "qualname": "find_closest_pairs", "kind": "function", "doc": "\n", "signature": "(x, y, **kw_args):", "funcdef": "def"}, "ramanchada2.misc.utils.argmin2d.align": {"fullname": "ramanchada2.misc.utils.argmin2d.align", "modulename": "ramanchada2.misc.utils.argmin2d", "qualname": "align", "kind": "function", "doc": "Iteratively finds best match between x and y and evaluates the x scaling parameters.\nmin((lambda(x, p)-y)*2 | *p)\nFinds best parameters *p that minimise L2 distance between scaled x and original y
\n", "signature": "(\tx,\ty,\tp0: Union[List[float], numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]]] = [0, 1, 0, 0],\tfunc=<function <lambda>>,\tmax_iter: typing.Annotated[int, Gt(gt=0)] = 1000,\t**kw_args):", "funcdef": "def"}, "ramanchada2.misc.utils.argmin2d.align_shift": {"fullname": "ramanchada2.misc.utils.argmin2d.align_shift", "modulename": "ramanchada2.misc.utils.argmin2d", "qualname": "align_shift", "kind": "function", "doc": "\n", "signature": "(\tx,\ty,\tp0: float = 0,\tmax_iter: typing.Annotated[int, Gt(gt=0)] = 1000,\t**kw_args):", "funcdef": "def"}, "ramanchada2.misc.utils.matchsets": {"fullname": "ramanchada2.misc.utils.matchsets", "modulename": "ramanchada2.misc.utils.matchsets", "kind": "module", "doc": "\n"}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"fullname": "ramanchada2.misc.utils.matchsets.match_peaks_cluster", "modulename": "ramanchada2.misc.utils.matchsets", "qualname": "match_peaks_cluster", "kind": "function", "doc": "\n", "signature": "(\tspe_pos_dict: Dict[float, float],\tref: Dict[float, float],\t_filter_range=True,\tcost_intensity=0.25):", "funcdef": "def"}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"fullname": "ramanchada2.misc.utils.matchsets.cost_function_position", "modulename": "ramanchada2.misc.utils.matchsets", "qualname": "cost_function_position", "kind": "function", "doc": "\n", "signature": "(\tp1: Dict[float, float],\tp2: Dict[float, float],\torder_weight=1.0,\tpriority_weight=1.0):", "funcdef": "def"}, "ramanchada2.misc.utils.matchsets.cost_function": {"fullname": "ramanchada2.misc.utils.matchsets.cost_function", "modulename": "ramanchada2.misc.utils.matchsets", "qualname": "cost_function", "kind": "function", "doc": "Modified cost function with an order preservation penalty and priority weighting.
\n\n\norder_weight
increases penalty for large differences in the x-axis values. \npriority_weight
decreases the cost for higher values in the y-axis for set_b points. \n
\n", "signature": "(\tp1: Dict[float, float],\tp2: Dict[float, float],\torder_weight=1.0,\tpriority_weight=0.1):", "funcdef": "def"}, "ramanchada2.misc.utils.matchsets.normalize_tuples": {"fullname": "ramanchada2.misc.utils.matchsets.normalize_tuples", "modulename": "ramanchada2.misc.utils.matchsets", "qualname": "normalize_tuples", "kind": "function", "doc": "\n", "signature": "(tuples):", "funcdef": "def"}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"fullname": "ramanchada2.misc.utils.matchsets.cost_matrix_peaks", "modulename": "ramanchada2.misc.utils.matchsets", "qualname": "cost_matrix_peaks", "kind": "function", "doc": "\n", "signature": "(\tspectrum_a_dict: Dict[float, float],\tspectrum_b_dict: Dict[float, float],\tthreshold_max_distance=9,\tcost_func=None):", "funcdef": "def"}, "ramanchada2.misc.utils.matchsets.match_peaks": {"fullname": "ramanchada2.misc.utils.matchsets.match_peaks", "modulename": "ramanchada2.misc.utils.matchsets", "qualname": "match_peaks", "kind": "function", "doc": "Match peaks between two spectra based on their positions and intensities.
\n\nUses scipy linear_sum_assignment to match peaks based on cost function\nhttps://docs.scipy.org/doc/scipy/reference/generated/scipy.optimize.linear_sum_assignment.html
\n\nParameters:
\n\nspectrum_a_dict : dict\n A dictionary representing the first spectrum, where keys are peak\n positions (float) and values are peak intensities (float).
\n\nspectrum_b_dict : dict\n A dictionary representing the second spectrum, where keys are peak\n positions (float) and values are peak intensities (float).
\n\nthreshold_max_distance : float, optional\n The maximum allowed distance for two peaks to be considered a match.\n Default is 8.
\n\ndf : bool, optional\n If True, return a DataFrame with matched peaks and their respective\n intensities; if False, return None
\n\nReturns:
\n\nmatched_peaks : (matched_peaks_a,matched_peaks_b,matched_distances, df)
\n\nExamples:
\n\n\n
>>> spectrum_a = {100: 10, 105: 20, 110: 15}\n>>> spectrum_b = {102: 12, 106: 22, 111: 16}\n>>> match_peaks(spectrum_a, spectrum_b)\n
\n
\n", "signature": "(\tspectrum_a_dict: Dict[float, float],\tspectrum_b_dict: Dict[float, float],\tthreshold_max_distance=9,\tdf=False,\tcost_func=None):", "funcdef": "def"}, "ramanchada2.misc.utils.ramanshift_to_wavelength": {"fullname": "ramanchada2.misc.utils.ramanshift_to_wavelength", "modulename": "ramanchada2.misc.utils.ramanshift_to_wavelength", "kind": "module", "doc": "\n"}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"fullname": "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict", "modulename": "ramanchada2.misc.utils.ramanshift_to_wavelength", "qualname": "shift_cm_1_to_abs_nm_dict", "kind": "function", "doc": "\n", "signature": "(deltas, laser_wave_length_nm):", "funcdef": "def"}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"fullname": "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict", "modulename": "ramanchada2.misc.utils.ramanshift_to_wavelength", "qualname": "abs_nm_to_shift_cm_1_dict", "kind": "function", "doc": "\n", "signature": "(deltas, laser_wave_length_nm):", "funcdef": "def"}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"fullname": "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1", "modulename": "ramanchada2.misc.utils.ramanshift_to_wavelength", "qualname": "abs_nm_to_shift_cm_1", "kind": "function", "doc": "\n", "signature": "(wl, laser_wave_length_nm):", "funcdef": "def"}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"fullname": "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm", "modulename": "ramanchada2.misc.utils.ramanshift_to_wavelength", "qualname": "shift_cm_1_to_abs_nm", "kind": "function", "doc": "\n", "signature": "(wn, laser_wave_length_nm):", "funcdef": "def"}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"fullname": "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm", "modulename": "ramanchada2.misc.utils.ramanshift_to_wavelength", "qualname": "laser_wl_nm", "kind": "function", "doc": "\n", "signature": "(raman_shift_cm_1, wave_length_nm):", "funcdef": "def"}, "ramanchada2.misc.utils.svd": {"fullname": "ramanchada2.misc.utils.svd", "modulename": "ramanchada2.misc.utils.svd", "kind": "module", "doc": "\n"}, "ramanchada2.misc.utils.svd.svd_solve": {"fullname": "ramanchada2.misc.utils.svd.svd_solve", "modulename": "ramanchada2.misc.utils.svd", "qualname": "svd_solve", "kind": "function", "doc": "Solves Ax=b
\n", "signature": "(A, b):", "funcdef": "def"}, "ramanchada2.misc.utils.svd.svd_inverse": {"fullname": "ramanchada2.misc.utils.svd.svd_inverse", "modulename": "ramanchada2.misc.utils.svd", "qualname": "svd_inverse", "kind": "function", "doc": "\n", "signature": "(mat):", "funcdef": "def"}, "ramanchada2.protocols": {"fullname": "ramanchada2.protocols", "modulename": "ramanchada2.protocols", "kind": "module", "doc": "\n"}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg": {"fullname": "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg", "modulename": "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg", "kind": "module", "doc": "\n"}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"fullname": "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration", "modulename": "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg", "qualname": "neon_calibration", "kind": "function", "doc": "\n", "signature": "(\tne_cm_1: ramanchada2.spectrum.spectrum.Spectrum,\twl: Literal[514, 532, 633, 785]):", "funcdef": "def"}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"fullname": "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration", "modulename": "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg", "qualname": "silicon_calibration", "kind": "function", "doc": "Calculate calibration function for lazer zeroing
\n\nArguments:
\n\n\n- si_nm: Spectrum\nSilicon spectrum
\n- wl: Literal[514, 532, 633, 785]\nLaser wavelength
\n- find_peaks_kw: dict, optional\nkeywords for find_peak. Default values are\n
{'prominence': min(.8, si_nm.y_noise_MAD()*50), 'width': 2, 'wlen': 100}
\n- fit_peaks_kw: dict, optional\nkeywords for fit_peaks. Default values are\n
{'profile': 'Pearson4', 'vary_baseline': False}
\n
\n\nReturns:
\n\n\n spline, esitmated_wavelength: int
\n
\n", "signature": "(\tsi_nm: ramanchada2.spectrum.spectrum.Spectrum,\twl: Literal[514, 532, 633, 785],\tfind_peaks_kw={},\tfit_peaks_kw={}):", "funcdef": "def"}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"fullname": "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration", "modulename": "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg", "qualname": "neon_silicon_calibration", "kind": "function", "doc": "\n", "signature": "(\tne_cm_1: ramanchada2.spectrum.spectrum.Spectrum,\tsi_cm_1: ramanchada2.spectrum.spectrum.Spectrum,\twl: Literal[514, 532, 633, 785],\tsil_fit_kw={},\tsil_find_kw={}):", "funcdef": "def"}, "ramanchada2.protocols.calibration": {"fullname": "ramanchada2.protocols.calibration", "modulename": "ramanchada2.protocols.calibration", "kind": "module", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component": {"fullname": "ramanchada2.protocols.calibration.calibration_component", "modulename": "ramanchada2.protocols.calibration.calibration_component", "kind": "module", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.logger": {"fullname": "ramanchada2.protocols.calibration.calibration_component.logger", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "logger", "kind": "variable", "doc": "\n", "default_value": "<Logger ramanchada2.protocols.calibration.calibration_component (WARNING)>"}, "ramanchada2.protocols.calibration.calibration_component.ProcessingModel": {"fullname": "ramanchada2.protocols.calibration.calibration_component.ProcessingModel", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "ProcessingModel", "kind": "class", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.misc.plottable.Plottable"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.__init__", "kind": "function", "doc": "\n", "signature": "(laser_wl, spe, spe_units, ref, ref_units, sample=None)"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.nonmonotonic", "kind": "variable", "doc": "\n", "annotation": ": Literal['ignore', 'nan', 'error']", "default_value": "'nan'"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.laser_wl", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.spe", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.spe_units", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.ref", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.ref_units", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.name", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.model", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.model_units", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.peaks", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.sample", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.enabled", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.fit_res", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.set_model", "kind": "function", "doc": "\n", "signature": "(self, model, model_units, peaks, name=None):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.convert_units", "kind": "function", "doc": "\n", "signature": "(self, old_spe, spe_unit='cm-1', newspe_unit='nm', laser_wl=None):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.process", "kind": "function", "doc": "\n", "signature": "(\tself,\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tspe_units='cm-1',\tconvert_back=False):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.derive_model", "kind": "function", "doc": "\n", "signature": "(self, find_kw=None, fit_peaks_kw=None, should_fit=False, name=None):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.plot", "kind": "function", "doc": "\n", "signature": "(self, ax=None, label=' ', **kwargs) -> matplotlib.axes._axes.Axes:", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"fullname": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df", "modulename": "ramanchada2.protocols.calibration.calibration_component", "qualname": "CalibrationComponent.fitres2df", "kind": "function", "doc": "\n", "signature": "(self, spe):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_model": {"fullname": "ramanchada2.protocols.calibration.calibration_model", "modulename": "ramanchada2.protocols.calibration.calibration_model", "kind": "module", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.protocols.calibration.calibration_component.ProcessingModel, ramanchada2.misc.plottable.Plottable"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.__init__", "kind": "function", "doc": "Initializes a CalibrationModel instance.
\n\nArguments:
\n\n\n- laser_wl: The wavelength of the laser used for calibration.
\n
\n\nExample:
\n\n\n
# Create an instance of CalibrationModel\nimport ramanchada2 as rc2\nimport ramanchada2.misc.constants as rc2const\nfrom ramanchada2.protocols.calibration import CalibrationModel\nlaser_wl=785\ncalmodel = CalibrationModel.calibration_model_factory(\n laser_wl,\n spe_neon,\n spe_sil,\n neon_wl=rc2const.NEON_WL[laser_wl],\n find_kw={"wlen": 200, "width": 1},\n fit_peaks_kw={},\n should_fit=False,\n)\n# Store (optional)\ncalmodel.save(modelfile)\n# Load (optional)\ncalmodel = CalibrationModel.from_file(modelfile)\n# Apply to new spectrum\ncalmodel.apply_calibration_x(\n spe_to_calibrate,\n spe_units="cm-1"\n )\n
\n
\n", "signature": "(laser_wl: int)"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.nonmonotonic", "kind": "variable", "doc": "A class representing a calibration model for Raman spectrum.
\n", "annotation": ": Literal['ignore', 'nan', 'error']", "default_value": "'nan'"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.prominence_coeff", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.set_laser_wavelength", "kind": "function", "doc": "Sets the wavelength of the laser used for calibration.
\n", "signature": "(self, laser_wl):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.clear", "kind": "function", "doc": "Clears the calibration model.
\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.save", "kind": "function", "doc": "Saves the calibration model to a file.
\n", "signature": "(self, filename):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.from_file", "kind": "function", "doc": "Loads a calibration model from a file.
\n", "signature": "(filename):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.derive_model_x", "kind": "function", "doc": "Derives x-calibration models using Neon and Silicon spectra.
\n", "signature": "(\tself,\tspe_neon: ramanchada2.spectrum.spectrum.Spectrum,\tspe_neon_units: str,\tref_neon: Dict,\tref_neon_units: str,\tspe_sil: ramanchada2.spectrum.spectrum.Spectrum,\tspe_sil_units='cm-1',\tref_sil={520.45: 1},\tref_sil_units='cm-1',\tfind_kw={'wlen': 200, 'width': 1},\tfit_kw={},\tshould_fit=False,\tmatch_method: Literal['cluster', 'argmin2d', 'assignment'] = 'cluster',\tinterpolator_method: Literal['rbf', 'pchip', 'cubic_spline'] = 'rbf',\textrapolate=True):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.derive_model_curve", "kind": "function", "doc": "\n", "signature": "(\tself,\tspe: ramanchada2.spectrum.spectrum.Spectrum,\tref=None,\tspe_units='cm-1',\tref_units='nm',\tfind_kw={},\tfit_peaks_kw={},\tshould_fit=False,\tname='X calibration',\tmatch_method: Literal['cluster', 'argmin2d', 'assignment'] = 'cluster',\tinterpolator_method: Literal['rbf', 'pchip', 'cubic_spline'] = 'rbf',\textrapolate=True):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.derive_model_zero", "kind": "function", "doc": "\n", "signature": "(\tself,\tspe: ramanchada2.spectrum.spectrum.Spectrum,\tref={520.45: 1},\tspe_units='nm',\tref_units='cm-1',\tfind_kw=None,\tfit_peaks_kw=None,\tshould_fit=False,\tname='X Shift',\tprofile='Pearson4'):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.apply_calibration_x", "kind": "function", "doc": "\n", "signature": "(\tself,\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tspe_units='cm-1'):", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.plot", "kind": "function", "doc": "\n", "signature": "(self, ax=None, label=' ', **kwargs) -> matplotlib.axes._axes.Axes:", "funcdef": "def"}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"fullname": "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory", "modulename": "ramanchada2.protocols.calibration.calibration_model", "qualname": "CalibrationModel.calibration_model_factory", "kind": "function", "doc": "\n", "signature": "(\tlaser_wl,\tspe_neon: ramanchada2.spectrum.spectrum.Spectrum,\tspe_sil: ramanchada2.spectrum.spectrum.Spectrum,\tneon_wl=None,\tfind_kw=None,\tfit_peaks_kw=None,\tshould_fit=False,\tprominence_coeff=3,\tsi_profile='Pearson4',\tmatch_method: Literal['cluster', 'argmin2d', 'assignment'] = 'cluster',\tinterpolator_method: Literal['rbf', 'pchip', 'cubic_spline'] = 'rbf',\textrapolate=True):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration": {"fullname": "ramanchada2.protocols.calibration.xcalibration", "modulename": "ramanchada2.protocols.calibration.xcalibration", "kind": "module", "doc": "\n"}, "ramanchada2.protocols.calibration.xcalibration.logger": {"fullname": "ramanchada2.protocols.calibration.xcalibration.logger", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "logger", "kind": "variable", "doc": "\n", "default_value": "<Logger ramanchada2.protocols.calibration.xcalibration (WARNING)>"}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"fullname": "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "XCalibrationComponent", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent"}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"fullname": "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "XCalibrationComponent.__init__", "kind": "function", "doc": "\n", "signature": "(\tlaser_wl,\tspe: ramanchada2.spectrum.spectrum.Spectrum,\tref: Dict[float, float],\tspe_units: Literal['cm-1', 'nm'] = 'cm-1',\tref_units: Literal['cm-1', 'nm'] = 'nm',\tsample='Neon',\tmatch_method: Literal['cluster', 'argmin2d', 'assignment'] = 'cluster',\tinterpolator_method: Literal['rbf', 'pchip', 'cubic_spline'] = 'rbf',\textrapolate=True)"}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"fullname": "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "XCalibrationComponent.spe_pos_dict", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"fullname": "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "XCalibrationComponent.match_method", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"fullname": "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "XCalibrationComponent.cost_function", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"fullname": "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "XCalibrationComponent.interpolator_method", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate": {"fullname": "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "XCalibrationComponent.extrapolate", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"fullname": "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "XCalibrationComponent.process", "kind": "function", "doc": "\n", "signature": "(\tself,\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tspe_units: Literal['cm-1', 'nm'] = 'cm-1',\tconvert_back=False):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"fullname": "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "XCalibrationComponent.derive_model", "kind": "function", "doc": "\n", "signature": "(self, find_kw=None, fit_peaks_kw=None, should_fit=False, name=None):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"fullname": "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "XCalibrationComponent.match_peaks", "kind": "function", "doc": "\n", "signature": "(self, threshold_max_distance=9, return_df=False):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"fullname": "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "XCalibrationComponent.fit_peaks", "kind": "function", "doc": "\n", "signature": "(self, find_kw, fit_peaks_kw, should_fit):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"fullname": "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "LazerZeroingComponent", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent"}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"fullname": "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "LazerZeroingComponent.__init__", "kind": "function", "doc": "\n", "signature": "(\tlaser_wl,\tspe: ramanchada2.spectrum.spectrum.Spectrum,\tspe_units: Literal['cm-1', 'nm'] = 'nm',\tref=None,\tref_units: Literal['cm-1', 'nm'] = 'cm-1',\tsample='Silicon',\tprofile='Pearson4')"}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile": {"fullname": "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "LazerZeroingComponent.profile", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"fullname": "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "LazerZeroingComponent.derive_model", "kind": "function", "doc": "\n", "signature": "(self, find_kw=None, fit_peaks_kw=None, should_fit=True, name=None):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"fullname": "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "LazerZeroingComponent.zero_nm_to_shift_cm_1", "kind": "function", "doc": "\n", "signature": "(self, wl, zero_pos_nm, zero_ref_cm_1=520.45):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"fullname": "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "LazerZeroingComponent.process", "kind": "function", "doc": "\n", "signature": "(\tself,\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tspe_units: Literal['cm-1', 'nm'] = 'nm',\tconvert_back=False):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomRBFInterpolator", "kind": "class", "doc": "Radial basis function (RBF) interpolation in N dimensions.
\n\nParameters
\n\ny : (npoints, ndims) array_like\n 2-D array of data point coordinates.\nd : (npoints, ...) array_like\n N-D array of data values at y
. The length of d
along the first\n axis must be equal to the length of y
. Unlike some interpolators, the\n interpolation axis cannot be changed.\nneighbors : int, optional\n If specified, the value of the interpolant at each evaluation point\n will be computed using only this many nearest data points. All the data\n points are used by default.\nsmoothing : float or (npoints, ) array_like, optional\n Smoothing parameter. The interpolant perfectly fits the data when this\n is set to 0. For large values, the interpolant approaches a least\n squares fit of a polynomial with the specified degree. Default is 0.\nkernel : str, optional\n Type of RBF. This should be one of
\n\n - 'linear' : ``-r``\n - 'thin_plate_spline' : ``r**2 * log(r)``\n - 'cubic' : ``r**3``\n - 'quintic' : ``-r**5``\n - 'multiquadric' : ``-sqrt(1 + r**2)``\n - 'inverse_multiquadric' : ``1/sqrt(1 + r**2)``\n - 'inverse_quadratic' : ``1/(1 + r**2)``\n - 'gaussian' : ``exp(-r**2)``\n\nDefault is 'thin_plate_spline'.\n
\n\nepsilon : float, optional\n Shape parameter that scales the input to the RBF. If kernel
is\n 'linear', 'thin_plate_spline', 'cubic', or 'quintic', this defaults to\n 1 and can be ignored because it has the same effect as scaling the\n smoothing parameter. Otherwise, this must be specified.\ndegree : int, optional\n Degree of the added polynomial. For some RBFs the interpolant may not\n be well-posed if the polynomial degree is too small. Those RBFs and\n their corresponding minimum degrees are
\n\n - 'multiquadric' : 0\n - 'linear' : 0\n - 'thin_plate_spline' : 1\n - 'cubic' : 1\n - 'quintic' : 2\n\nThe default value is the minimum degree for `kernel` or 0 if there is\nno minimum degree. Set this to -1 for no added polynomial.\n
\n\nNotes
\n\nAn RBF is a scalar valued function in N-dimensional space whose value at\n\\( x \\) can be expressed in terms of \\( r=||x - c|| \\), where \\( c \\)\nis the center of the RBF.
\n\nAn RBF interpolant for the vector of data values \\( d \\), which are from\nlocations \\( y \\), is a linear combination of RBFs centered at \\( y \\)\nplus a polynomial with a specified degree. The RBF interpolant is written\nas
\n\n$$f(x) = K(x, y) a + P(x) b,$$
\n\nwhere \\( K(x, y) \\) is a matrix of RBFs with centers at \\( y \\)\nevaluated at the points \\( x \\), and \\( P(x) \\) is a matrix of\nmonomials, which span polynomials with the specified degree, evaluated at\n\\( x \\). The coefficients \\( a \\) and \\( b \\) are the solution to the\nlinear equations
\n\n$$(K(y, y) + \\lambda I) a + P(y) b = d$$
\n\nand
\n\n$$P(y)^T a = 0,$$
\n\nwhere \\( \\lambda \\) is a non-negative smoothing parameter that controls\nhow well we want to fit the data. The data are fit exactly when the\nsmoothing parameter is 0.
\n\nThe above system is uniquely solvable if the following requirements are\nmet:
\n\n- \\\\( P(y) \\\\) must have full column rank. \\\\( P(y) \\\\) always has full\n column rank when `degree` is -1 or 0. When `degree` is 1,\n \\\\( P(y) \\\\) has full column rank if the data point locations are not\n all collinear (N=2), coplanar (N=3), etc.\n- If `kernel` is 'multiquadric', 'linear', 'thin_plate_spline',\n 'cubic', or 'quintic', then `degree` must not be lower than the\n minimum value listed above.\n- If `smoothing` is 0, then each data point location must be distinct.\n
\n\nWhen using an RBF that is not scale invariant ('multiquadric',\n'inverse_multiquadric', 'inverse_quadratic', or 'gaussian'), an appropriate\nshape parameter must be chosen (e.g., through cross validation). Smaller\nvalues for the shape parameter correspond to wider RBFs. The problem can\nbecome ill-conditioned or singular when the shape parameter is too small.
\n\nThe memory required to solve for the RBF interpolation coefficients\nincreases quadratically with the number of data points, which can become\nimpractical when interpolating more than about a thousand data points.\nTo overcome memory limitations for large interpolation problems, the\nneighbors
argument can be specified to compute an RBF interpolant for\neach evaluation point using only the nearest data points.
\n\nNew in version 1.7.0.
\n\nSee Also
\n\nNearestNDInterpolator\nLinearNDInterpolator\nCloughTocher2DInterpolator
\n\nReferences
\n\nExamples
\n\nDemonstrate interpolating scattered data to a grid in 2-D.
\n\n\n
>>> import numpy as np\n>>> import matplotlib.pyplot as plt\n>>> from scipy.interpolate import RBFInterpolator\n>>> from scipy.stats.qmc import Halton\n
\n
\n\n\n
>>> rng = np.random.default_rng()\n>>> xobs = 2*Halton(2, seed=rng).random(100) - 1\n>>> yobs = np.sum(xobs, axis=1)*np.exp(-6*np.sum(xobs**2, axis=1))\n
\n
\n\n\n
>>> xgrid = np.mgrid[-1:1:50j, -1:1:50j]\n>>> xflat = xgrid.reshape(2, -1).T\n>>> yflat = RBFInterpolator(xobs, yobs)(xflat)\n>>> ygrid = yflat.reshape(50, 50)\n
\n
\n\n\n
>>> fig, ax = plt.subplots()\n>>> ax.pcolormesh(*xgrid, ygrid, vmin=-0.25, vmax=0.25, shading='gouraud')\n>>> p = ax.scatter(*xobs.T, c=yobs, s=50, ec='k', vmin=-0.25, vmax=0.25)\n>>> fig.colorbar(p)\n>>> plt.show()\n
\n
\n\n\n", "bases": "scipy.interpolate._rbfinterp.RBFInterpolator"}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomRBFInterpolator.__init__", "kind": "function", "doc": "\n", "signature": "(*args, **kwargs)"}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomRBFInterpolator.from_dict", "kind": "function", "doc": "\n", "signature": "(rbf_dict=None):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomRBFInterpolator.to_dict", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomRBFInterpolator.plot", "kind": "function", "doc": "\n", "signature": "(self, ax):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomPChipInterpolator", "kind": "class", "doc": "PCHIP 1-D monotonic cubic interpolation.
\n\nx
and y
are arrays of values used to approximate some function f,\nwith y = f(x)
. The interpolant uses monotonic cubic splines\nto find the value of new points. (PCHIP stands for Piecewise Cubic\nHermite Interpolating Polynomial).
\n\nParameters
\n\nx : ndarray, shape (npoints, )\n A 1-D array of monotonically increasing real values. x
cannot\n include duplicate values (otherwise f is overspecified)\ny : ndarray, shape (..., npoints, ...)\n A N-D array of real values. y
's length along the interpolation\n axis must be equal to the length of x
. Use the axis
\n parameter to select the interpolation axis.
\n\n*Deprecated since version 1.13.0:*\nComplex data is deprecated and will raise an error in SciPy 1.15.0.\nIf you are trying to use the real components of the passed array,\nuse ``np.real`` on ``y``.\n
\n\naxis : int, optional\n Axis in the y
array corresponding to the x-coordinate values. Defaults\n to axis=0
.\nextrapolate : bool, optional\n Whether to extrapolate to out-of-bounds points based on first\n and last intervals, or to return NaNs.
\n\nMethods
\n\n__call__\nderivative\nantiderivative\nroots
\n\nSee Also
\n\nCubicHermiteSpline : Piecewise-cubic interpolator.\nAkima1DInterpolator : Akima 1D interpolator.\nCubicSpline : Cubic spline data interpolator.\nPPoly : Piecewise polynomial in terms of coefficients and breakpoints.
\n\nNotes
\n\nThe interpolator preserves monotonicity in the interpolation data and does\nnot overshoot if the data is not smooth.
\n\nThe first derivatives are guaranteed to be continuous, but the second\nderivatives may jump at \\( x_k \\).
\n\nDetermines the derivatives at the points \\( x_k \\), \\( f'_k \\),\nby using PCHIP algorithm .
\n\nLet \\( h_k = x_{k+1} - x_k \\), and \\( d_k = (y_{k+1} - y_k) / h_k \\)\nare the slopes at internal points \\( x_k \\).\nIf the signs of \\( d_k \\) and \\( d_{k-1} \\) are different or either of\nthem equals zero, then \\( f'_k = 0 \\). Otherwise, it is given by the\nweighted harmonic mean
\n\n$$\\frac{w_1 + w_2}{f'_k} = \\frac{w_1}{d_{k-1}} + \\frac{w_2}{d_k}$$
\n\nwhere \\( w_1 = 2 h_k + h_{k-1} \\) and \\( w_2 = h_k + 2 h_{k-1} \\).
\n\nThe end slopes are set using a one-sided scheme .
\n\nReferences
\n\n\n", "bases": "scipy.interpolate._cubic.PchipInterpolator"}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomPChipInterpolator.__init__", "kind": "function", "doc": "\n", "signature": "(x, y)"}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomPChipInterpolator.x", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomPChipInterpolator.y", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomPChipInterpolator.from_dict", "kind": "function", "doc": "\n", "signature": "(pchip_dict=None):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomPChipInterpolator.to_dict", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomPChipInterpolator.save_coefficients", "kind": "function", "doc": "Save the x and y coefficients to a JSON file.
\n", "signature": "(self, filename):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomPChipInterpolator.load_coefficients", "kind": "function", "doc": "Load the coefficients from a JSON file.
\n", "signature": "(cls, filename):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomPChipInterpolator.plot", "kind": "function", "doc": "Plot the interpolation curve and the original points.
\n", "signature": "(self, ax):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomCubicSplineInterpolator", "kind": "class", "doc": "Cubic spline data interpolator.
\n\nInterpolate data with a piecewise cubic polynomial which is twice\ncontinuously differentiable . The result is represented as a PPoly
\ninstance with breakpoints matching the given data.
\n\nParameters
\n\nx : array_like, shape (n,)\n 1-D array containing values of the independent variable.\n Values must be real, finite and in strictly increasing order.\ny : array_like\n Array containing values of the dependent variable. It can have\n arbitrary number of dimensions, but the length along axis
\n (see below) must match the length of x
. Values must be finite.\naxis : int, optional\n Axis along which y
is assumed to be varying. Meaning that for\n x[i]
the corresponding values are np.take(y, i, axis=axis)
.\n Default is 0.\nbc_type : string or 2-tuple, optional\n Boundary condition type. Two additional equations, given by the\n boundary conditions, are required to determine all coefficients of\n polynomials on each segment .
\n\nIf `bc_type` is a string, then the specified condition will be applied\nat both ends of a spline. Available conditions are:\n\n* 'not-a-knot' (default): The first and second segment at a curve end\n are the same polynomial. It is a good default when there is no\n information on boundary conditions.\n* 'periodic': The interpolated functions is assumed to be periodic\n of period ``x[-1] - x[0]``. The first and last value of `y` must be\n identical: ``y[0] == y[-1]``. This boundary condition will result in\n ``y'[0] == y'[-1]`` and ``y''[0] == y''[-1]``.\n* 'clamped': The first derivative at curves ends are zero. Assuming\n a 1D `y`, ``bc_type=((1, 0.0), (1, 0.0))`` is the same condition.\n* 'natural': The second derivative at curve ends are zero. Assuming\n a 1D `y`, ``bc_type=((2, 0.0), (2, 0.0))`` is the same condition.\n\nIf `bc_type` is a 2-tuple, the first and the second value will be\napplied at the curve start and end respectively. The tuple values can\nbe one of the previously mentioned strings (except 'periodic') or a\ntuple `(order, deriv_values)` allowing to specify arbitrary\nderivatives at curve ends:\n\n* `order`: the derivative order, 1 or 2.\n* `deriv_value`: array_like containing derivative values, shape must\n be the same as `y`, excluding ``axis`` dimension. For example, if\n `y` is 1-D, then `deriv_value` must be a scalar. If `y` is 3-D with\n the shape (n0, n1, n2) and axis=2, then `deriv_value` must be 2-D\n and have the shape (n0, n1).\n
\n\nextrapolate : {bool, 'periodic', None}, optional\n If bool, determines whether to extrapolate to out-of-bounds points\n based on first and last intervals, or to return NaNs. If 'periodic',\n periodic extrapolation is used. If None (default), extrapolate
is\n set to 'periodic' for bc_type='periodic'
and to True otherwise.
\n\nAttributes
\n\nx : ndarray, shape (n,)\n Breakpoints. The same x
which was passed to the constructor.\nc : ndarray, shape (4, n-1, ...)\n Coefficients of the polynomials on each segment. The trailing\n dimensions match the dimensions of y
, excluding axis
.\n For example, if y
is 1-d, then c[k, i]
is a coefficient for\n (x-x[i])**(3-k)
on the segment between x[i]
and x[i+1]
.\naxis : int\n Interpolation axis. The same axis which was passed to the\n constructor.
\n\nMethods
\n\n__call__\nderivative\nantiderivative\nintegrate\nroots
\n\nSee Also
\n\nAkima1DInterpolator : Akima 1D interpolator.\nPchipInterpolator : PCHIP 1-D monotonic cubic interpolator.\nPPoly : Piecewise polynomial in terms of coefficients and breakpoints.
\n\nNotes
\n\nParameters bc_type
and extrapolate
work independently, i.e. the\nformer controls only construction of a spline, and the latter only\nevaluation.
\n\nWhen a boundary condition is 'not-a-knot' and n = 2, it is replaced by\na condition that the first derivative is equal to the linear interpolant\nslope. When both boundary conditions are 'not-a-knot' and n = 3, the\nsolution is sought as a parabola passing through given points.
\n\nWhen 'not-a-knot' boundary conditions is applied to both ends, the\nresulting spline will be the same as returned by splrep
(with s=0
)\nand InterpolatedUnivariateSpline
, but these two methods use a\nrepresentation in B-spline basis.
\n\nNew in version 0.18.0.
\n\nExamples
\n\nIn this example the cubic spline is used to interpolate a sampled sinusoid.\nYou can see that the spline continuity property holds for the first and\nsecond derivatives and violates only for the third derivative.
\n\n\n
>>> import numpy as np\n>>> from scipy.interpolate import CubicSpline\n>>> import matplotlib.pyplot as plt\n>>> x = np.arange(10)\n>>> y = np.sin(x)\n>>> cs = CubicSpline(x, y)\n>>> xs = np.arange(-0.5, 9.6, 0.1)\n>>> fig, ax = plt.subplots(figsize=(6.5, 4))\n>>> ax.plot(x, y, 'o', label='data')\n>>> ax.plot(xs, np.sin(xs), label='true')\n>>> ax.plot(xs, cs(xs), label="S")\n>>> ax.plot(xs, cs(xs, 1), label="S'")\n>>> ax.plot(xs, cs(xs, 2), label="S''")\n>>> ax.plot(xs, cs(xs, 3), label="S'''")\n>>> ax.set_xlim(-0.5, 9.5)\n>>> ax.legend(loc='lower left', ncol=2)\n>>> plt.show()\n
\n
\n\nIn the second example, the unit circle is interpolated with a spline. A\nperiodic boundary condition is used. You can see that the first derivative\nvalues, ds/dx=0, ds/dy=1 at the periodic point (1, 0) are correctly\ncomputed. Note that a circle cannot be exactly represented by a cubic\nspline. To increase precision, more breakpoints would be required.
\n\n\n
>>> theta = 2 * np.pi * np.linspace(0, 1, 5)\n>>> y = np.c_[np.cos(theta), np.sin(theta)]\n>>> cs = CubicSpline(theta, y, bc_type='periodic')\n>>> print("ds/dx={:.1f} ds/dy={:.1f}".format(cs(0, 1)[0], cs(0, 1)[1]))\nds/dx=0.0 ds/dy=1.0\n>>> xs = 2 * np.pi * np.linspace(0, 1, 100)\n>>> fig, ax = plt.subplots(figsize=(6.5, 4))\n>>> ax.plot(y[:, 0], y[:, 1], 'o', label='data')\n>>> ax.plot(np.cos(xs), np.sin(xs), label='true')\n>>> ax.plot(cs(xs)[:, 0], cs(xs)[:, 1], label='spline')\n>>> ax.axes.set_aspect('equal')\n>>> ax.legend(loc='center')\n>>> plt.show()\n
\n
\n\nThe third example is the interpolation of a polynomial y = x3 on the\ninterval 0 <= x<= 1. A cubic spline can represent this function exactly.\nTo achieve that we need to specify values and first derivatives at\nendpoints of the interval. Note that y' = 3 * x2 and thus y'(0) = 0 and\ny'(1) = 3.
\n\n\n
>>> cs = CubicSpline([0, 1], [0, 1], bc_type=((1, 0), (1, 3)))\n>>> x = np.linspace(0, 1)\n>>> np.allclose(x**3, cs(x))\nTrue\n
\n
\n\nReferences
\n\n\n", "bases": "scipy.interpolate._cubic.CubicSpline"}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomCubicSplineInterpolator.__init__", "kind": "function", "doc": "\n", "signature": "(*args, **kwargs)"}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomCubicSplineInterpolator.from_dict", "kind": "function", "doc": "\n", "signature": "(spline_dict=None):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomCubicSplineInterpolator.to_dict", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"fullname": "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot", "modulename": "ramanchada2.protocols.calibration.xcalibration", "qualname": "CustomCubicSplineInterpolator.plot", "kind": "function", "doc": "\n", "signature": "(self, ax):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration": {"fullname": "ramanchada2.protocols.calibration.ycalibration", "modulename": "ramanchada2.protocols.calibration.ycalibration", "kind": "module", "doc": "\n"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate", "kind": "class", "doc": "Class for intensity calibration certificates
\n\nUsage:
\n\n\n \n - Use for specific SRM\n \n
\n
>>> cert = YCalibrationCertificate(\n... id="NIST785_SRM2241",\n... description="optical glass",\n... url="https://tsapps.nist.gov/srmext/certificates/2241.pdf",\n... wavelength=785,\n... params="A0 = 9.71937e-02, A1 = 2.28325e-04, A2 = -5.86762e-08, A3 = 2.16023e-10, A4 = -9.77171e-14, A5 = 1.15596e-17",\n... equation="A0 + A1 * x + A2 * x**2 + A3 * x**3 + A4 * x**4 + A5 * x**5",\n... temperature_c=(20, 25),\n... raman_shift=(200, 3500)\n... )\n...\n>>> cert.plot()\n
\n
\n \n
\n
\n", "bases": "pydantic.main.BaseModel, ramanchada2.misc.plottable.Plottable"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.id", "kind": "variable", "doc": "\n", "annotation": ": str"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.description", "kind": "variable", "doc": "\n", "annotation": ": Optional[str]"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.url", "kind": "variable", "doc": "\n", "annotation": ": Optional[str]"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.wavelength", "kind": "variable", "doc": "\n", "annotation": ": int"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.params", "kind": "variable", "doc": "\n", "annotation": ": str"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.equation", "kind": "variable", "doc": "\n", "annotation": ": str"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.temperature_c", "kind": "variable", "doc": "\n", "annotation": ": Optional[Tuple[int, int]]"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.raman_shift", "kind": "variable", "doc": "\n", "annotation": ": Optional[Tuple[int, int]]"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.response_function", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.Y", "kind": "function", "doc": "\n", "signature": "(self, x_value):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.load", "kind": "function", "doc": "\n", "signature": "(wavelength=785, key='NIST785_SRM2241'):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.model_config", "kind": "variable", "doc": "Configuration for the model, should be a dictionary conforming to [ConfigDict
][pydantic.config.ConfigDict].
\n", "annotation": ": ClassVar[pydantic.config.ConfigDict]", "default_value": "{}"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.model_fields", "kind": "variable", "doc": "Metadata about the fields defined on the model,\nmapping of field names to [FieldInfo
][pydantic.fields.FieldInfo] objects.
\n\nThis replaces Model.__fields__
from Pydantic V1.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.FieldInfo]]", "default_value": "{'id': FieldInfo(annotation=str, required=True), 'description': FieldInfo(annotation=Union[str, NoneType], required=True), 'url': FieldInfo(annotation=Union[str, NoneType], required=True), 'wavelength': FieldInfo(annotation=int, required=True), 'params': FieldInfo(annotation=str, required=True), 'equation': FieldInfo(annotation=str, required=True), 'temperature_c': FieldInfo(annotation=Union[Tuple[int, int], NoneType], required=True), 'raman_shift': FieldInfo(annotation=Union[Tuple[int, int], NoneType], required=True)}"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationCertificate.model_computed_fields", "kind": "variable", "doc": "A dictionary of computed field names and their corresponding ComputedFieldInfo
objects.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.ComputedFieldInfo]]", "default_value": "{}"}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"fullname": "ramanchada2.protocols.calibration.ycalibration.CertificatesDict", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "CertificatesDict", "kind": "class", "doc": "Class for loading y calibration certificates
\n\nUsage:
\n\n\n Load single certificate
\n \n \n
>>> cert = CertificatesDict.load(wavelength="785", key="NIST785_SRM2241")\n>>> cert.plot()\n
\n
\n \n Load all certificates for wavelength. Iterate :
\n \n \n
>>> certificates = CertificatesDict()\n... plt.figure()\n... ax=None\n... certs = certificates.get_certificates(wavelength=532)\n... ax = certs[cert].plot(ax=ax)\n>>> plt.show()\n
\n
\n
\n"}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"fullname": "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "CertificatesDict.load_certificates", "kind": "function", "doc": "\n", "signature": "(self, file_path):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"fullname": "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "CertificatesDict.get_laser_wl", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"fullname": "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "CertificatesDict.get_certificates", "kind": "function", "doc": "\n", "signature": "(self, wavelength=785):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"fullname": "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "CertificatesDict.get", "kind": "function", "doc": "\n", "signature": "(self, wavelength=532, key='NIST532_SRM2242a'):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"fullname": "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "CertificatesDict.load", "kind": "function", "doc": "\n", "signature": "(wavelength=785, key='NIST785_SRM2241'):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent", "kind": "class", "doc": "Class for relative intensity calibration. Uses response functions loaded in\nResponseFunctionEvaluator. Functions are defined in json file.
\n\nUsage:
\n\n\n \n
>>> laser_wl = 785\n>>> ycert = YCalibrationCertificate.load(wavelength=785, key="SRM2241")\n>>> ycal = YCalibrationComponent(laser_wl, reference_spe_xcalibrated=spe_srm,certificate=ycert)\n>>> fig, ax = plt.subplots(1, 1, figsize=(15,4))\n>>> spe_srm.plot(ax=ax)\n>>> spe_to_correct.plot(ax=ax)\n>>> spe_ycalibrated = ycal.process(spe_to_correct)\n>>> spe_ycalibrated.plot(label="y-calibrated",color="green",ax=ax.twinx())\n
\n
\n
\n", "bases": "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.__init__", "kind": "function", "doc": "\n", "signature": "(\tlaser_wl,\treference_spe_xcalibrated,\tcertificate: ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate)"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.laser_wl", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.spe", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.ref", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.name", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.model", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.model_units", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.derive_model", "kind": "function", "doc": "\n", "signature": "(self, find_kw=None, fit_peaks_kw=None, should_fit=True, name=None):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.safe_divide", "kind": "function", "doc": "\n", "signature": "(self, spe_to_correct, spe_reference_resampled):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.safe_mask", "kind": "function", "doc": "\n", "signature": "(self, spe_to_correct, spe_reference_resampled):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.safe_factor", "kind": "function", "doc": "\n", "signature": "(self, spe_to_correct, spe_reference_resampled):", "funcdef": "def"}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"fullname": "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process", "modulename": "ramanchada2.protocols.calibration.ycalibration", "qualname": "YCalibrationComponent.process", "kind": "function", "doc": "\n", "signature": "(\tself,\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tspe_units='nm',\tconvert_back=False):", "funcdef": "def"}, "ramanchada2.protocols.metadata_helper": {"fullname": "ramanchada2.protocols.metadata_helper", "modulename": "ramanchada2.protocols.metadata_helper", "kind": "module", "doc": "\n"}, "ramanchada2.protocols.metadata_helper.MetadataExtractor": {"fullname": "ramanchada2.protocols.metadata_helper.MetadataExtractor", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "MetadataExtractor", "kind": "class", "doc": "\n"}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"fullname": "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "MetadataExtractor.extract", "kind": "function", "doc": "\n", "signature": "(self, spectrum, filename=None):", "funcdef": "def"}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor": {"fullname": "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "TemplateMetadataExtractor", "kind": "class", "doc": "\n", "bases": "MetadataExtractor"}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"fullname": "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "TemplateMetadataExtractor.__init__", "kind": "function", "doc": "\n", "signature": "(template)"}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template": {"fullname": "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "TemplateMetadataExtractor.template", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"fullname": "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "TemplateMetadataExtractor.extract", "kind": "function", "doc": "\n", "signature": "(self, spectrum, filename=None):", "funcdef": "def"}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor": {"fullname": "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "FilenameMetadataExtractor", "kind": "class", "doc": "\n", "bases": "MetadataExtractor"}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"fullname": "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "FilenameMetadataExtractor.extract", "kind": "function", "doc": "\n", "signature": "(self, spectrum, filename):", "funcdef": "def"}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor": {"fullname": "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "SpectrumMetadataExtractor", "kind": "class", "doc": "\n", "bases": "MetadataExtractor"}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"fullname": "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "SpectrumMetadataExtractor.extract", "kind": "function", "doc": "\n", "signature": "(self, spectrum, filename=None):", "funcdef": "def"}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor": {"fullname": "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "ChainedMetadataExtractor", "kind": "class", "doc": "\n", "bases": "MetadataExtractor"}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"fullname": "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "ChainedMetadataExtractor.__init__", "kind": "function", "doc": "\n", "signature": "(*extractors)"}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors": {"fullname": "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "ChainedMetadataExtractor.extractors", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"fullname": "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract", "modulename": "ramanchada2.protocols.metadata_helper", "qualname": "ChainedMetadataExtractor.extract", "kind": "function", "doc": "\n", "signature": "(self, spectrum, filename=None):", "funcdef": "def"}, "ramanchada2.protocols.spectraframe": {"fullname": "ramanchada2.protocols.spectraframe", "modulename": "ramanchada2.protocols.spectraframe", "kind": "module", "doc": "\n"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/
\n\nA base class for creating Pydantic models.
\n\nAttributes:
\n\n\n- __class_vars__: The names of the class variables defined on the model.
\n- __private_attributes__: Metadata about the private attributes of the model.
\n- __signature__: The synthesized
__init__
[Signature
][inspect.Signature] of the model. \n- __pydantic_complete__: Whether model building is completed, or if there are still undefined fields.
\n- __pydantic_core_schema__: The core schema of the model.
\n- __pydantic_custom_init__: Whether the model has a custom
__init__
function. \n- __pydantic_decorators__: Metadata containing the decorators defined on the model.\nThis replaces
Model.__validators__
and Model.__root_validators__
from Pydantic V1. \n- __pydantic_generic_metadata__: Metadata for generic models; contains data used for a similar purpose to\n__args__, __origin__, __parameters__ in typing-module generics. May eventually be replaced by these.
\n- __pydantic_parent_namespace__: Parent namespace of the model, used for automatic rebuilding of models.
\n- __pydantic_post_init__: The name of the post-init method for the model, if defined.
\n- __pydantic_root_model__: Whether the model is a [
RootModel
][pydantic.root_model.RootModel]. \n- __pydantic_serializer__: The
pydantic-core
SchemaSerializer
used to dump instances of the model. \n- __pydantic_validator__: The
pydantic-core
SchemaValidator
used to validate instances of the model. \n- __pydantic_extra__: A dictionary containing extra values, if [
extra
][pydantic.config.ConfigDict.extra]\nis set to 'allow'
. \n- __pydantic_fields_set__: The names of fields explicitly set during instantiation.
\n- __pydantic_private__: Values of private attributes set on the model instance.
\n
\n", "bases": "pydantic.main.BaseModel"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.file_name", "kind": "variable", "doc": "\n", "annotation": ": Optional[str]"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.sample", "kind": "variable", "doc": "\n", "annotation": ": Optional[str]"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.provider", "kind": "variable", "doc": "\n", "annotation": ": Optional[str]"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.device", "kind": "variable", "doc": "\n", "annotation": ": Optional[str]"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.device_id", "kind": "variable", "doc": "\n", "annotation": ": Optional[str]"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.laser_wl", "kind": "variable", "doc": "\n", "annotation": ": int"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.laser_power_mW", "kind": "variable", "doc": "\n", "annotation": ": Optional[float]"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.laser_power_percent", "kind": "variable", "doc": "\n", "annotation": ": Optional[float]"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.time_ms", "kind": "variable", "doc": "\n", "annotation": ": Optional[float]"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.replicate", "kind": "variable", "doc": "\n", "annotation": ": Optional[int]"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.optical_path", "kind": "variable", "doc": "\n", "annotation": ": Optional[str]"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.spectrum", "kind": "variable", "doc": "\n", "annotation": ": Optional[ramanchada2.spectrum.spectrum.Spectrum]"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.Config", "kind": "class", "doc": "\n"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.Config.arbitrary_types_allowed", "kind": "variable", "doc": "\n", "default_value": "True"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.model_config", "kind": "variable", "doc": "Configuration for the model, should be a dictionary conforming to [ConfigDict
][pydantic.config.ConfigDict].
\n", "annotation": ": ClassVar[pydantic.config.ConfigDict]", "default_value": "{'arbitrary_types_allowed': True}"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.model_fields", "kind": "variable", "doc": "Metadata about the fields defined on the model,\nmapping of field names to [FieldInfo
][pydantic.fields.FieldInfo] objects.
\n\nThis replaces Model.__fields__
from Pydantic V1.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.FieldInfo]]", "default_value": "{'file_name': FieldInfo(annotation=Union[str, NoneType], required=False, default=None), 'sample': FieldInfo(annotation=Union[str, NoneType], required=False, default=None), 'provider': FieldInfo(annotation=Union[str, NoneType], required=False, default=None), 'device': FieldInfo(annotation=Union[str, NoneType], required=False, default=None), 'device_id': FieldInfo(annotation=Union[str, NoneType], required=False, default=None), 'laser_wl': FieldInfo(annotation=int, required=True), 'laser_power_mW': FieldInfo(annotation=Union[float, NoneType], required=False, default=None), 'laser_power_percent': FieldInfo(annotation=Union[float, NoneType], required=False, default=None), 'time_ms': FieldInfo(annotation=Union[float, NoneType], required=False, default=None), 'replicate': FieldInfo(annotation=Union[int, NoneType], required=False, default=None), 'optical_path': FieldInfo(annotation=Union[str, NoneType], required=False, default=None), 'spectrum': FieldInfo(annotation=Union[Spectrum, NoneType], required=False, default=None)}"}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrameSchema.model_computed_fields", "kind": "variable", "doc": "A dictionary of computed field names and their corresponding ComputedFieldInfo
objects.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.ComputedFieldInfo]]", "default_value": "{}"}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrame", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrame", "kind": "class", "doc": "Two-dimensional, size-mutable, potentially heterogeneous tabular data.
\n\nData structure also contains labeled axes (rows and columns).\nArithmetic operations align on both row and column labels. Can be\nthought of as a dict-like container for Series objects. The primary\npandas data structure.
\n\nParameters
\n\ndata : ndarray (structured or homogeneous), Iterable, dict, or DataFrame\n Dict can contain Series, arrays, constants, dataclass or list-like objects. If\n data is a dict, column order follows insertion-order. If a dict contains Series\n which have an index defined, it is aligned by its index. This alignment also\n occurs if data is a Series or a DataFrame itself. Alignment is done on\n Series/DataFrame inputs.
\n\nIf data is a list of dicts, column order follows insertion-order.\n
\n\nindex : Index or array-like\n Index to use for resulting frame. Will default to RangeIndex if\n no indexing information part of input data and no index provided.\ncolumns : Index or array-like\n Column labels to use for resulting frame when data does not have them,\n defaulting to RangeIndex(0, 1, 2, ..., n). If data contains column labels,\n will perform column selection instead.\ndtype : dtype, default None\n Data type to force. Only a single dtype is allowed. If None, infer.\ncopy : bool or None, default None\n Copy data from inputs.\n For dict data, the default of None behaves like copy=True
. For DataFrame\n or 2d ndarray input, the default of None behaves like copy=False
.\n If data is a dict containing one or more Series (possibly of different dtypes),\n copy=False
will ensure that these inputs are not copied.
\n\n*Changed in version 1.3.0.*\n
\n\nSee Also
\n\nDataFrame.from_records : Constructor from tuples, also record arrays.\nDataFrame.from_dict : From dicts of Series, arrays, or dicts.\nread_csv : Read a comma-separated values (csv) file into DataFrame.\nread_table : Read general delimited file into DataFrame.\nread_clipboard : Read text from clipboard into DataFrame.
\n\nNotes
\n\nPlease reference the :ref:User Guide <basics.dataframe>
for more information.
\n\nExamples
\n\nConstructing DataFrame from a dictionary.
\n\n\n
>>> d = {'col1': [1, 2], 'col2': [3, 4]}\n>>> df = pd.DataFrame(data=d)\n>>> df\n col1 col2\n0 1 3\n1 2 4\n
\n
\n\nNotice that the inferred dtype is int64.
\n\n\n
>>> df.dtypes\ncol1 int64\ncol2 int64\ndtype: object\n
\n
\n\nTo enforce a single dtype:
\n\n\n
>>> df = pd.DataFrame(data=d, dtype=np.int8)\n>>> df.dtypes\ncol1 int8\ncol2 int8\ndtype: object\n
\n
\n\nConstructing DataFrame from a dictionary including Series:
\n\n\n
>>> d = {'col1': [0, 1, 2, 3], 'col2': pd.Series([2, 3], index=[2, 3])}\n>>> pd.DataFrame(data=d, index=[0, 1, 2, 3])\n col1 col2\n0 0 NaN\n1 1 NaN\n2 2 2.0\n3 3 3.0\n
\n
\n\nConstructing DataFrame from numpy ndarray:
\n\n\n
>>> df2 = pd.DataFrame(np.array([[1, 2, 3], [4, 5, 6], [7, 8, 9]]),\n... columns=['a', 'b', 'c'])\n>>> df2\n a b c\n0 1 2 3\n1 4 5 6\n2 7 8 9\n
\n
\n\nConstructing DataFrame from a numpy ndarray that has labeled columns:
\n\n\n
>>> data = np.array([(1, 2, 3), (4, 5, 6), (7, 8, 9)],\n... dtype=[("a", "i4"), ("b", "i4"), ("c", "i4")])\n>>> df3 = pd.DataFrame(data, columns=['c', 'a'])\n...\n>>> df3\n c a\n0 3 1\n1 6 4\n2 9 7\n
\n
\n\nConstructing DataFrame from dataclass:
\n\n\n
>>> from dataclasses import make_dataclass\n>>> Point = make_dataclass("Point", [("x", int), ("y", int)])\n>>> pd.DataFrame([Point(0, 0), Point(0, 3), Point(2, 3)])\n x y\n0 0 0\n1 0 3\n2 2 3\n
\n
\n\nConstructing DataFrame from Series/DataFrame:
\n\n\n
>>> ser = pd.Series([1, 2, 3], index=["a", "b", "c"])\n>>> df = pd.DataFrame(data=ser, index=["a", "c"])\n>>> df\n 0\na 1\nc 3\n
\n
\n\n\n
>>> df1 = pd.DataFrame([1, 2, 3], index=["a", "b", "c"], columns=["x"])\n>>> df2 = pd.DataFrame(data=df1, index=["a", "c"])\n>>> df2\n x\na 1\nc 3\n
\n
\n", "bases": "pandas.core.frame.DataFrame"}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrame.validate_columns", "kind": "function", "doc": "Validate a DataFrame against the schema with dynamic column mapping.
\n\nArguments:
\n\n\n- df (pd.DataFrame): The DataFrame to validate.
\n- column_mapping (Dict[str, str]): A mapping from expected column names (in the schema)\nto actual column names in the DataFrame.
\n
\n", "signature": "(cls, df: pandas.core.frame.DataFrame, column_mapping: Dict[str, str]):", "funcdef": "def"}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrame.from_dataframe", "kind": "function", "doc": "Create an instance of SpectraFrame with dynamic column validation.
\n\nArguments:
\n\n\n- df (pd.DataFrame): The input DataFrame.
\n- column_mapping (Dict[str, str]): The dynamic mapping for column names.
\n
\n\nReturns:
\n\n\n SpectraFrame: A validated SpectraFrame object.
\n
\n", "signature": "(cls, df: pandas.core.frame.DataFrame, column_mapping: Dict[str, str]):", "funcdef": "def"}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrame.from_metadata", "kind": "function", "doc": "\n", "signature": "(\tcls,\tspectra: List[ramanchada2.spectrum.spectrum.Spectrum],\tmetadata_extractor: ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor):", "funcdef": "def"}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrame.from_template", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrame.from_template", "kind": "function", "doc": "\n", "signature": "(\tcls,\ttemplate_file: str,\tmetadata_extractor: ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor):", "funcdef": "def"}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrame.average", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrame.average", "kind": "function", "doc": "\n", "signature": "(\tself,\tgrouping_cols=['sample', 'provider', 'device', 'laser_wl', 'laser_power_percent', 'laser_power_mW', 'time_ms'],\tsource='spectrum',\ttarget='spectrum'):", "funcdef": "def"}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrame.trim", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrame.trim", "kind": "function", "doc": "\n", "signature": "(self, source='spectrum', target='spectrum', **kwargs):", "funcdef": "def"}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrame.baseline_snip", "kind": "function", "doc": "\n", "signature": "(self, source='spectrum', target='spectrum', **kwargs):", "funcdef": "def"}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrame.spe_area", "kind": "function", "doc": "\n", "signature": "(self, boundaries=(50, 3000), source='spectrum', target='area'):", "funcdef": "def"}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"fullname": "ramanchada2.protocols.spectraframe.SpectraFrame.multiply", "modulename": "ramanchada2.protocols.spectraframe", "qualname": "SpectraFrame.multiply", "kind": "function", "doc": "Get Multiplication of dataframe and other, element-wise (binary operator mul
).
\n\nEquivalent to dataframe * other
, but with support to substitute a fill_value\nfor missing data in one of the inputs. With reverse version, rmul
.
\n\nAmong flexible wrappers (add
, sub
, mul
, div
, floordiv
, mod
, pow
) to\narithmetic operators: +
, -
, *
, /
, //
, %
, **
.
\n\nParameters
\n\nother : scalar, sequence, Series, dict or DataFrame\n Any single or multiple element data structure, or list-like object.\naxis : {0 or 'index', 1 or 'columns'}\n Whether to compare by the index (0 or 'index') or columns.\n (1 or 'columns'). For Series input, axis to match Series index on.\nlevel : int or label\n Broadcast across a level, matching Index values on the\n passed MultiIndex level.\nfill_value : float or None, default None\n Fill existing missing (NaN) values, and any new element needed for\n successful DataFrame alignment, with this value before computation.\n If data in both corresponding DataFrame locations is missing\n the result will be missing.
\n\nReturns
\n\nDataFrame\n Result of the arithmetic operation.
\n\nSee Also
\n\nDataFrame.add : Add DataFrames.\nDataFrame.sub : Subtract DataFrames.\nDataFrame.mul : Multiply DataFrames.\nDataFrame.div : Divide DataFrames (float division).\nDataFrame.truediv : Divide DataFrames (float division).\nDataFrame.floordiv : Divide DataFrames (integer division).\nDataFrame.mod : Calculate modulo (remainder after division).\nDataFrame.pow : Calculate exponential power.
\n\nNotes
\n\nMismatched indices will be unioned together.
\n\nExamples
\n\n\n
>>> df = pd.DataFrame({'angles': [0, 3, 4],\n... 'degrees': [360, 180, 360]},\n... index=['circle', 'triangle', 'rectangle'])\n>>> df\n angles degrees\ncircle 0 360\ntriangle 3 180\nrectangle 4 360\n
\n
\n\nAdd a scalar with operator version which return the same\nresults.
\n\n\n
>>> df + 1\n angles degrees\ncircle 1 361\ntriangle 4 181\nrectangle 5 361\n
\n
\n\n\n
>>> df.add(1)\n angles degrees\ncircle 1 361\ntriangle 4 181\nrectangle 5 361\n
\n
\n\nDivide by constant with reverse version.
\n\n\n
>>> df.div(10)\n angles degrees\ncircle 0.0 36.0\ntriangle 0.3 18.0\nrectangle 0.4 36.0\n
\n
\n\n\n
>>> df.rdiv(10)\n angles degrees\ncircle inf 0.027778\ntriangle 3.333333 0.055556\nrectangle 2.500000 0.027778\n
\n
\n\nSubtract a list and Series by axis with operator version.
\n\n\n
>>> df - [1, 2]\n angles degrees\ncircle -1 358\ntriangle 2 178\nrectangle 3 358\n
\n
\n\n\n
>>> df.sub([1, 2], axis='columns')\n angles degrees\ncircle -1 358\ntriangle 2 178\nrectangle 3 358\n
\n
\n\n\n
>>> df.sub(pd.Series([1, 1, 1], index=['circle', 'triangle', 'rectangle']),\n... axis='index')\n angles degrees\ncircle -1 359\ntriangle 2 179\nrectangle 3 359\n
\n
\n\nMultiply a dictionary by axis.
\n\n\n
>>> df.mul({'angles': 0, 'degrees': 2})\n angles degrees\ncircle 0 720\ntriangle 0 360\nrectangle 0 720\n
\n
\n\n\n
>>> df.mul({'circle': 0, 'triangle': 2, 'rectangle': 3}, axis='index')\n angles degrees\ncircle 0 0\ntriangle 6 360\nrectangle 12 1080\n
\n
\n\nMultiply a DataFrame of different shape with operator version.
\n\n\n
>>> other = pd.DataFrame({'angles': [0, 3, 4]},\n... index=['circle', 'triangle', 'rectangle'])\n>>> other\n angles\ncircle 0\ntriangle 3\nrectangle 4\n
\n
\n\n\n
>>> df * other\n angles degrees\ncircle 0 NaN\ntriangle 9 NaN\nrectangle 16 NaN\n
\n
\n\n\n
>>> df.mul(other, fill_value=0)\n angles degrees\ncircle 0 0.0\ntriangle 9 0.0\nrectangle 16 0.0\n
\n
\n\nDivide by a MultiIndex by level.
\n\n\n
>>> df_multindex = pd.DataFrame({'angles': [0, 3, 4, 4, 5, 6],\n... 'degrees': [360, 180, 360, 360, 540, 720]},\n... index=[['A', 'A', 'A', 'B', 'B', 'B'],\n... ['circle', 'triangle', 'rectangle',\n... 'square', 'pentagon', 'hexagon']])\n>>> df_multindex\n angles degrees\nA circle 0 360\n triangle 3 180\n rectangle 4 360\nB square 4 360\n pentagon 5 540\n hexagon 6 720\n
\n
\n\n\n
>>> df.div(df_multindex, level=1, fill_value=0)\n angles degrees\nA circle NaN 1.0\n triangle 1.0 1.0\n rectangle 1.0 1.0\nB square 0.0 0.0\n pentagon 0.0 0.0\n hexagon 0.0 0.0\n
\n
\n", "signature": "(self, multiplier: float, source='spectrum', target='spectrum'):", "funcdef": "def"}, "ramanchada2.protocols.twinning": {"fullname": "ramanchada2.protocols.twinning", "modulename": "ramanchada2.protocols.twinning", "kind": "module", "doc": "\n"}, "ramanchada2.protocols.twinning.TwinningComponent": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent", "kind": "class", "doc": "TwinningComponent is an implementation of CHARISMA Twinning protocol CWA18134 Sep 2024\nhttps://www.cencenelec.eu/media/CEN-CENELEC/CWAs/RI/2024/cwa18134-1.pdf\nIt expects reference spectra and test spectra (to be twinned) as SpectraFrame objects.
\n\nAttributes:
\n\n\n- grouping_cols (list): The SpectraFrame may contain replicates, which will be averaged by grouping by\ncolumns except replicates, e.g.\n['sample', 'provider', 'laser_wl', 'laser_power_percent', 'laser_power_mW', 'time_ms'].
\n- reference (SpectraFrame): The averaged reference spectra.
\n- twinned (SpectraFrame): The averaged spectra to be twinned.
\n- boundaries (tuple): A tuple representing the boundaries for analysis (default: (50, 2000)).
\n- linreg_reference (tuple): Placeholder for storing the result of a linear regression on the reference spectra.\nDefaults to a tuple (None, None) which can later hold the regression slope and intercept.
\n- linreg_twinned (tuple): Placeholder for storing the result of a linear regression on the twinned spectra.\nDefaults to a tuple (None, None) which can later hold the regression slope and intercept.
\n- correction_factor (float): A scaling factor derived as ratio of slopes as defined in CWA18134.
\n- peak (float): The position of the peak (in nm) of interest for analysis, with a default value of 144 (TiO2).
\n
\n\nMethods:
\n\n\n __init__(self, twinned: SpectraFrame, reference: SpectraFrame, boundaries=None, peak_at=144):\n Initializes a new TwinningComponent object by averaging the provided twinned and reference spectra\n based on predefined grouping columns. Optionally, boundaries for analysis and a peak position can be\n specified.
\n
\n\nArguments:
\n\n\n- twinned (SpectraFrame): The SpectraFrame representing the twinned data.
\n- reference (SpectraFrame): The SpectraFrame representing the reference data.
\n- boundaries (tuple, optional): Optional boundary values to restrict the analysis region (default: (50, 2000)).
\n- peak_at (int, optional): The peak position to focus the analysis on (default: 144 for TiO2).
\n
\n", "bases": "ramanchada2.misc.plottable.Plottable"}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.__init__", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.__init__", "kind": "function", "doc": "\n", "signature": "(\ttwinned: ramanchada2.protocols.spectraframe.SpectraFrame,\treference: ramanchada2.protocols.spectraframe.SpectraFrame,\tboundaries=None,\treference_band_nm=144.0,\tgrouping_cols=['sample', 'provider', 'device', 'laser_wl', 'laser_power_percent', 'laser_power_mW', 'time_ms'])"}, "ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.grouping_cols", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.grouping_cols", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.twinning.TwinningComponent.twinned": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.twinned", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.twinned", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.twinning.TwinningComponent.reference": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.reference", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.reference", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.twinning.TwinningComponent.boundaries": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.boundaries", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.boundaries", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.linreg_reference", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.linreg_reference", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.linreg_twinned", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.correction_factor", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.correction_factor", "kind": "variable", "doc": "\n", "annotation": ": float"}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.reference_band_nm", "kind": "variable", "doc": "\n"}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.normalize_by_laserpower_time", "kind": "function", "doc": "\n", "signature": "(self, source='spectrum', target='spectrum'):", "funcdef": "def"}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.calc_peak_intensity", "kind": "function", "doc": "\n", "signature": "(\tself,\tspe: ramanchada2.spectrum.spectrum.Spectrum,\tboundaries=None,\tprominence_coeff=0.01,\tno_fit=False,\tpeak_intensity='height'):", "funcdef": "def"}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.laser_power_regression", "kind": "function", "doc": "\n", "signature": "(\tself,\tdf: ramanchada2.protocols.spectraframe.SpectraFrame,\tboundaries=None,\tno_fit=False,\tsource='spectrum'):", "funcdef": "def"}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.process", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.process", "kind": "function", "doc": "\n", "signature": "(\tself,\tspe: ramanchada2.protocols.spectraframe.SpectraFrame,\tsource='spectrum',\ttarget='spectrum_harmonized'):", "funcdef": "def"}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.derive_model", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.derive_model", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"fullname": "ramanchada2.protocols.twinning.TwinningComponent.plot", "modulename": "ramanchada2.protocols.twinning", "qualname": "TwinningComponent.plot", "kind": "function", "doc": "\n", "signature": "(self, ax=None, label=' ', **kwargs) -> matplotlib.axes._axes.Axes:", "funcdef": "def"}, "ramanchada2.spectral_components": {"fullname": "ramanchada2.spectral_components", "modulename": "ramanchada2.spectral_components", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.baseline": {"fullname": "ramanchada2.spectral_components.baseline", "modulename": "ramanchada2.spectral_components.baseline", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.baseline.analytical": {"fullname": "ramanchada2.spectral_components.baseline.analytical", "modulename": "ramanchada2.spectral_components.baseline.analytical", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.baseline.baseline_base": {"fullname": "ramanchada2.spectral_components.baseline.baseline_base", "modulename": "ramanchada2.spectral_components.baseline.baseline_base", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"fullname": "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase", "modulename": "ramanchada2.spectral_components.baseline.baseline_base", "qualname": "BaseLineBase", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.spectral_components.spectral_component.SpectralComponent"}, "ramanchada2.spectral_components.baseline.numerical": {"fullname": "ramanchada2.spectral_components.baseline.numerical", "modulename": "ramanchada2.spectral_components.baseline.numerical", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"fullname": "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical", "modulename": "ramanchada2.spectral_components.baseline.numerical", "qualname": "BaselineNumerical", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase"}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"fullname": "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__", "modulename": "ramanchada2.spectral_components.baseline.numerical", "qualname": "BaselineNumerical.__init__", "kind": "function", "doc": "Numerical baseline
\n\nArguments:
\n\n\n- x: array-like
\n- y: array-like
\n
\n", "signature": "(x, y)"}, "ramanchada2.spectral_components.peak_profile": {"fullname": "ramanchada2.spectral_components.peak_profile", "modulename": "ramanchada2.spectral_components.peak_profile", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.delta": {"fullname": "ramanchada2.spectral_components.peak_profile.delta", "modulename": "ramanchada2.spectral_components.peak_profile.delta", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"fullname": "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak", "modulename": "ramanchada2.spectral_components.peak_profile.delta", "qualname": "DeltasPeak", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.spectral_components.spectral_peak.SpectralPeak"}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"fullname": "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__", "modulename": "ramanchada2.spectral_components.peak_profile.delta", "qualname": "DeltasPeak.__init__", "kind": "function", "doc": "\n", "signature": "(**kwargs)"}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"fullname": "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a", "modulename": "ramanchada2.spectral_components.peak_profile.delta", "qualname": "DeltasPeak.a", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"fullname": "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0", "modulename": "ramanchada2.spectral_components.peak_profile.delta", "qualname": "DeltasPeak.x0", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"fullname": "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta", "modulename": "ramanchada2.spectral_components.peak_profile.delta", "qualname": "DeltasPeak.delta", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"fullname": "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm", "modulename": "ramanchada2.spectral_components.peak_profile.delta", "qualname": "DeltasPeak.pos_amp_fwhm", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"fullname": "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma", "modulename": "ramanchada2.spectral_components.peak_profile.delta", "qualname": "DeltasPeak.limit_3sigma", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.gauss": {"fullname": "ramanchada2.spectral_components.peak_profile.gauss", "modulename": "ramanchada2.spectral_components.peak_profile.gauss", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"fullname": "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak", "modulename": "ramanchada2.spectral_components.peak_profile.gauss", "qualname": "GaussPeak", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.spectral_components.spectral_peak.SpectralPeak"}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"fullname": "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__", "modulename": "ramanchada2.spectral_components.peak_profile.gauss", "qualname": "GaussPeak.__init__", "kind": "function", "doc": "\n", "signature": "(**kwargs)"}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"fullname": "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a", "modulename": "ramanchada2.spectral_components.peak_profile.gauss", "qualname": "GaussPeak.a", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"fullname": "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0", "modulename": "ramanchada2.spectral_components.peak_profile.gauss", "qualname": "GaussPeak.x0", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"fullname": "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w", "modulename": "ramanchada2.spectral_components.peak_profile.gauss", "qualname": "GaussPeak.w", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"fullname": "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta", "modulename": "ramanchada2.spectral_components.peak_profile.gauss", "qualname": "GaussPeak.delta", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"fullname": "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm", "modulename": "ramanchada2.spectral_components.peak_profile.gauss", "qualname": "GaussPeak.pos_amp_fwhm", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"fullname": "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma", "modulename": "ramanchada2.spectral_components.peak_profile.gauss", "qualname": "GaussPeak.limit_3sigma", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.voigt": {"fullname": "ramanchada2.spectral_components.peak_profile.voigt", "modulename": "ramanchada2.spectral_components.peak_profile.voigt", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"fullname": "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak", "modulename": "ramanchada2.spectral_components.peak_profile.voigt", "qualname": "VoigtPeak", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.spectral_components.spectral_peak.SpectralPeak"}, "ramanchada2.spectral_components.spectral_component": {"fullname": "ramanchada2.spectral_components.spectral_component", "modulename": "ramanchada2.spectral_components.spectral_component", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"fullname": "ramanchada2.spectral_components.spectral_component.SpectralComponent", "modulename": "ramanchada2.spectral_components.spectral_component", "qualname": "SpectralComponent", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.misc.plottable.Plottable, ramanchada2.misc.base_class.BaseClass"}, "ramanchada2.spectral_components.spectral_component_collection": {"fullname": "ramanchada2.spectral_components.spectral_component_collection", "modulename": "ramanchada2.spectral_components.spectral_component_collection", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"fullname": "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection", "modulename": "ramanchada2.spectral_components.spectral_component_collection", "qualname": "SpectralComponentCollection", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.misc.plottable.Plottable, ramanchada2.misc.base_class.BaseClass"}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"fullname": "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__", "modulename": "ramanchada2.spectral_components.spectral_component_collection", "qualname": "SpectralComponentCollection.__init__", "kind": "function", "doc": "\n", "signature": "(peaks, **kwargs)"}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"fullname": "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs", "modulename": "ramanchada2.spectral_components.spectral_component_collection", "qualname": "SpectralComponentCollection.kwargs", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"fullname": "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin", "modulename": "ramanchada2.spectral_components.spectral_component_collection", "qualname": "SpectralComponentCollection.reset_origin", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"fullname": "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas", "modulename": "ramanchada2.spectral_components.spectral_component_collection", "qualname": "SpectralComponentCollection.get_deltas", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"fullname": "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve", "modulename": "ramanchada2.spectral_components.spectral_component_collection", "qualname": "SpectralComponentCollection.get_curve", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"fullname": "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma", "modulename": "ramanchada2.spectral_components.spectral_component_collection", "qualname": "SpectralComponentCollection.limit_3sigma", "kind": "variable", "doc": "\n"}, "ramanchada2.spectral_components.spectral_peak": {"fullname": "ramanchada2.spectral_components.spectral_peak", "modulename": "ramanchada2.spectral_components.spectral_peak", "kind": "module", "doc": "\n"}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"fullname": "ramanchada2.spectral_components.spectral_peak.SpectralPeak", "modulename": "ramanchada2.spectral_components.spectral_peak", "qualname": "SpectralPeak", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.spectral_components.spectral_component.SpectralComponent, abc.ABC"}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"fullname": "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta", "modulename": "ramanchada2.spectral_components.spectral_peak", "qualname": "SpectralPeak.delta", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"fullname": "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma", "modulename": "ramanchada2.spectral_components.spectral_peak", "qualname": "SpectralPeak.limit_3sigma", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"fullname": "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm", "modulename": "ramanchada2.spectral_components.spectral_peak", "qualname": "SpectralPeak.pos_amp_fwhm", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.spectrum": {"fullname": "ramanchada2.spectrum", "modulename": "ramanchada2.spectrum", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.arithmetics": {"fullname": "ramanchada2.spectrum.arithmetics", "modulename": "ramanchada2.spectrum.arithmetics", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.arithmetics.add": {"fullname": "ramanchada2.spectrum.arithmetics.add", "modulename": "ramanchada2.spectrum.arithmetics.add", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.arithmetics.mul": {"fullname": "ramanchada2.spectrum.arithmetics.mul", "modulename": "ramanchada2.spectrum.arithmetics.mul", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.arithmetics.sub": {"fullname": "ramanchada2.spectrum.arithmetics.sub", "modulename": "ramanchada2.spectrum.arithmetics.sub", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.arithmetics.truediv": {"fullname": "ramanchada2.spectrum.arithmetics.truediv", "modulename": "ramanchada2.spectrum.arithmetics.truediv", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.baseline": {"fullname": "ramanchada2.spectrum.baseline", "modulename": "ramanchada2.spectrum.baseline", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.baseline.add_baseline": {"fullname": "ramanchada2.spectrum.baseline.add_baseline", "modulename": "ramanchada2.spectrum.baseline.add_baseline", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"fullname": "ramanchada2.spectrum.baseline.add_baseline.generate_baseline", "modulename": "ramanchada2.spectrum.baseline.add_baseline", "qualname": "generate_baseline", "kind": "function", "doc": "\n", "signature": "(\tn_freq: int = FieldInfo(annotation=int, required=True, metadata=[Gt(gt=2)]),\tsize: int = FieldInfo(annotation=int, required=True, metadata=[Gt(gt=2)]),\trng_seed=None):", "funcdef": "def"}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"fullname": "ramanchada2.spectrum.baseline.add_baseline.add_baseline", "modulename": "ramanchada2.spectrum.baseline.add_baseline", "qualname": "add_baseline", "kind": "function", "doc": "Add artificial baseline to the spectrum.\nA random baseline is generated in frequency domain using uniform random numbers.\nThe baseline in frequency domain is tapered with bohman window to reduce the bandwidth\nof the baseline to first n_freq
frequencies and is transformed to \"time\" domain.\nAdditionaly by using func
parameter the user can define arbitrary function\nto be added as baseline.
\n\nArguments:
\n\n\n- n_freq: Must be
> 2
. Number of lowest frequency bins distinct from zero. \n- amplitude: Upper boundary for the uniform random generator.
\n- pedestal: Additive constant pedestal to the spectrum.
\n- func: Callable. User-defined function to be added as baseline. Example:
func = lambda x: x*.01 + x**2*.0001
. \n- rng_seed:
int
, optional. Seed for the random generator. \n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_freq: int,\tamplitude: float,\tpedestal: float = 0,\tfunc: Optional[Callable] = None,\trng_seed=None):", "funcdef": "def"}, "ramanchada2.spectrum.baseline.baseline_rc1": {"fullname": "ramanchada2.spectrum.baseline.baseline_rc1", "modulename": "ramanchada2.spectrum.baseline.baseline_rc1", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"fullname": "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als", "modulename": "ramanchada2.spectrum.baseline.baseline_rc1", "qualname": "baseline_als", "kind": "function", "doc": "\n", "signature": "(\ty,\tlam: float = 100000.0,\tp: float = 0.001,\tniter: typing.Annotated[int, Gt(gt=0)] = 100,\tsmooth: Union[Annotated[int, Gt(gt=0)], Literal[0]] = 7):", "funcdef": "def"}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"fullname": "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip", "modulename": "ramanchada2.spectrum.baseline.baseline_rc1", "qualname": "baseline_snip", "kind": "function", "doc": "\n", "signature": "(y0, niter: typing.Annotated[int, Gt(gt=0)] = 30):", "funcdef": "def"}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"fullname": "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als", "modulename": "ramanchada2.spectrum.baseline.baseline_rc1", "qualname": "subtract_baseline_rc1_als", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\tlam=100000.0,\tp=0.001,\tniter=100,\tsmooth=7):", "funcdef": "def"}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"fullname": "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip", "modulename": "ramanchada2.spectrum.baseline.baseline_rc1", "qualname": "subtract_baseline_rc1_snip", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\tniter=30):", "funcdef": "def"}, "ramanchada2.spectrum.baseline.moving_minimum": {"fullname": "ramanchada2.spectrum.baseline.moving_minimum", "modulename": "ramanchada2.spectrum.baseline.moving_minimum", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"fullname": "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum", "modulename": "ramanchada2.spectrum.baseline.moving_minimum", "qualname": "moving_minimum", "kind": "function", "doc": "Moving minimum baseline estimator.\nSuccessive values are calculated as minima of rolling rectangular window.
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\twindow_size: int):", "funcdef": "def"}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"fullname": "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum", "modulename": "ramanchada2.spectrum.baseline.moving_minimum", "qualname": "subtract_moving_minimum", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\twindow_size: int):", "funcdef": "def"}, "ramanchada2.spectrum.calc": {"fullname": "ramanchada2.spectrum.calc", "modulename": "ramanchada2.spectrum.calc", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.calc.central_moments": {"fullname": "ramanchada2.spectrum.calc.central_moments", "modulename": "ramanchada2.spectrum.calc.central_moments", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"fullname": "ramanchada2.spectrum.calc.central_moments.central_moments", "modulename": "ramanchada2.spectrum.calc.central_moments", "qualname": "central_moments", "kind": "function", "doc": "\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tboundaries=(-inf, inf),\tmoments=[1, 2, 3, 4],\tnormalize=False):", "funcdef": "def"}, "ramanchada2.spectrum.calibration": {"fullname": "ramanchada2.spectrum.calibration", "modulename": "ramanchada2.spectrum.calibration", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.calibration.by_deltas": {"fullname": "ramanchada2.spectrum.calibration.by_deltas", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "DeltaSpeModel", "kind": "class", "doc": "\n"}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "DeltaSpeModel.__init__", "kind": "function", "doc": "\n", "signature": "(deltas: Dict[float, float], shift=0, scale=1)"}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "DeltaSpeModel.params", "kind": "variable", "doc": "\n"}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "DeltaSpeModel.minx", "kind": "variable", "doc": "\n"}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "DeltaSpeModel.maxx", "kind": "variable", "doc": "\n"}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "DeltaSpeModel.model", "kind": "variable", "doc": "\n"}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "DeltaSpeModel.fit", "kind": "function", "doc": "\n", "signature": "(self, spe, sigma, ax=None, no_fit=False):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.ParamBounds", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "ParamBounds", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/
\n\nA base class for creating Pydantic models.
\n\nAttributes:
\n\n\n- __class_vars__: The names of the class variables defined on the model.
\n- __private_attributes__: Metadata about the private attributes of the model.
\n- __signature__: The synthesized
__init__
[Signature
][inspect.Signature] of the model. \n- __pydantic_complete__: Whether model building is completed, or if there are still undefined fields.
\n- __pydantic_core_schema__: The core schema of the model.
\n- __pydantic_custom_init__: Whether the model has a custom
__init__
function. \n- __pydantic_decorators__: Metadata containing the decorators defined on the model.\nThis replaces
Model.__validators__
and Model.__root_validators__
from Pydantic V1. \n- __pydantic_generic_metadata__: Metadata for generic models; contains data used for a similar purpose to\n__args__, __origin__, __parameters__ in typing-module generics. May eventually be replaced by these.
\n- __pydantic_parent_namespace__: Parent namespace of the model, used for automatic rebuilding of models.
\n- __pydantic_post_init__: The name of the post-init method for the model, if defined.
\n- __pydantic_root_model__: Whether the model is a [
RootModel
][pydantic.root_model.RootModel]. \n- __pydantic_serializer__: The
pydantic-core
SchemaSerializer
used to dump instances of the model. \n- __pydantic_validator__: The
pydantic-core
SchemaValidator
used to validate instances of the model. \n- __pydantic_extra__: A dictionary containing extra values, if [
extra
][pydantic.config.ConfigDict.extra]\nis set to 'allow'
. \n- __pydantic_fields_set__: The names of fields explicitly set during instantiation.
\n- __pydantic_private__: Values of private attributes set on the model instance.
\n
\n", "bases": "pydantic.main.BaseModel"}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "ParamBounds.min", "kind": "variable", "doc": "\n", "annotation": ": float"}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "ParamBounds.max", "kind": "variable", "doc": "\n", "annotation": ": float"}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "ParamBounds.model_config", "kind": "variable", "doc": "Configuration for the model, should be a dictionary conforming to [ConfigDict
][pydantic.config.ConfigDict].
\n", "annotation": ": ClassVar[pydantic.config.ConfigDict]", "default_value": "{}"}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "ParamBounds.model_fields", "kind": "variable", "doc": "Metadata about the fields defined on the model,\nmapping of field names to [FieldInfo
][pydantic.fields.FieldInfo] objects.
\n\nThis replaces Model.__fields__
from Pydantic V1.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.FieldInfo]]", "default_value": "{'min': FieldInfo(annotation=float, required=False, default=-inf), 'max': FieldInfo(annotation=float, required=False, default=inf)}"}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "ParamBounds.model_computed_fields", "kind": "variable", "doc": "A dictionary of computed field names and their corresponding ComputedFieldInfo
objects.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.ComputedFieldInfo]]", "default_value": "{}"}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.FitBounds", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "FitBounds", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/
\n\nA base class for creating Pydantic models.
\n\nAttributes:
\n\n\n- __class_vars__: The names of the class variables defined on the model.
\n- __private_attributes__: Metadata about the private attributes of the model.
\n- __signature__: The synthesized
__init__
[Signature
][inspect.Signature] of the model. \n- __pydantic_complete__: Whether model building is completed, or if there are still undefined fields.
\n- __pydantic_core_schema__: The core schema of the model.
\n- __pydantic_custom_init__: Whether the model has a custom
__init__
function. \n- __pydantic_decorators__: Metadata containing the decorators defined on the model.\nThis replaces
Model.__validators__
and Model.__root_validators__
from Pydantic V1. \n- __pydantic_generic_metadata__: Metadata for generic models; contains data used for a similar purpose to\n__args__, __origin__, __parameters__ in typing-module generics. May eventually be replaced by these.
\n- __pydantic_parent_namespace__: Parent namespace of the model, used for automatic rebuilding of models.
\n- __pydantic_post_init__: The name of the post-init method for the model, if defined.
\n- __pydantic_root_model__: Whether the model is a [
RootModel
][pydantic.root_model.RootModel]. \n- __pydantic_serializer__: The
pydantic-core
SchemaSerializer
used to dump instances of the model. \n- __pydantic_validator__: The
pydantic-core
SchemaValidator
used to validate instances of the model. \n- __pydantic_extra__: A dictionary containing extra values, if [
extra
][pydantic.config.ConfigDict.extra]\nis set to 'allow'
. \n- __pydantic_fields_set__: The names of fields explicitly set during instantiation.
\n- __pydantic_private__: Values of private attributes set on the model instance.
\n
\n", "bases": "pydantic.main.BaseModel"}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "FitBounds.shift", "kind": "variable", "doc": "\n", "annotation": ": ramanchada2.spectrum.calibration.by_deltas.ParamBounds"}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "FitBounds.scale", "kind": "variable", "doc": "\n", "annotation": ": ramanchada2.spectrum.calibration.by_deltas.ParamBounds"}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "FitBounds.scale2", "kind": "variable", "doc": "\n", "annotation": ": ramanchada2.spectrum.calibration.by_deltas.ParamBounds"}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "FitBounds.scale3", "kind": "variable", "doc": "\n", "annotation": ": ramanchada2.spectrum.calibration.by_deltas.ParamBounds"}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "FitBounds.model_config", "kind": "variable", "doc": "Configuration for the model, should be a dictionary conforming to [ConfigDict
][pydantic.config.ConfigDict].
\n", "annotation": ": ClassVar[pydantic.config.ConfigDict]", "default_value": "{}"}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "FitBounds.model_fields", "kind": "variable", "doc": "Metadata about the fields defined on the model,\nmapping of field names to [FieldInfo
][pydantic.fields.FieldInfo] objects.
\n\nThis replaces Model.__fields__
from Pydantic V1.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.FieldInfo]]", "default_value": "{'shift': FieldInfo(annotation=ParamBounds, required=False, default=ParamBounds(min=-inf, max=inf)), 'scale': FieldInfo(annotation=ParamBounds, required=False, default=ParamBounds(min=-inf, max=inf)), 'scale2': FieldInfo(annotation=ParamBounds, required=False, default=ParamBounds(min=-inf, max=inf)), 'scale3': FieldInfo(annotation=ParamBounds, required=False, default=ParamBounds(min=-inf, max=inf))}"}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "FitBounds.model_computed_fields", "kind": "variable", "doc": "A dictionary of computed field names and their corresponding ComputedFieldInfo
objects.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.ComputedFieldInfo]]", "default_value": "{}"}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "calibrate_by_deltas_model", "kind": "function", "doc": "\n- Builds a composite model based on a set of user specified delta lines.
\n- Initial guess is calculated based on 10-th and 90-th percentiles of\nthe distributions.
\n
\n\nThe phasespace of the model is flat with big amount of narrow minima.\nIn order to find the best fit, the experimental data are successively\nconvolved with gaussians with different widths startign from wide to\nnarrow. The model for the calibration is 3-th order polynomial, which\npotentialy can be changed for higher order polynomial. In order to avoid\nsolving the inverse of the calibration function, the result is tabulated\nand interpolated linarly for each bin of the spectrum.\nThis alogrithm is useful for corse calibration.
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tdeltas: Dict[float, float],\tbounds: Optional[ramanchada2.spectrum.calibration.by_deltas.FitBounds] = None,\tconvolution_steps: Optional[List[float]] = [15, 1],\tscale2=True,\tscale3=False,\tinit_guess: Literal[None, 'cumulative'] = None,\tax=None,\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "calibrate_by_deltas_filter", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tdeltas: Dict[float, float],\tconvolution_steps,\tinit_guess=None,\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.xcal_fine", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "xcal_fine", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*,\tref: Union[Dict[float, float], List[float]],\tshould_fit=False,\tpoly_order: typing.Annotated[int, Ge(ge=0)],\tfind_peaks_kw={}):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "xcal_fine_RBF", "kind": "function", "doc": "Wavelength calibration using Radial basis fuction interpolation
\n\nPlease be cautious! Interpolation might not be the most appropriate\napproach for this type of calibration.
\n\n**kwargs are passed to RBFInterpolator
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*,\tref: Union[Dict[float, float], List[float], numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]]],\tshould_fit=False,\tkernel: Literal['thin_plate_spline', 'cubic', 'quintic', 'multiquadric', 'inverse_multiquadric', 'inverse_quadratic', 'gaussian'] = 'thin_plate_spline',\tfind_peaks_kw={},\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"fullname": "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass", "modulename": "ramanchada2.spectrum.calibration.by_deltas", "qualname": "xcal_argmin2d_iter_lowpass", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*,\tref: Dict[float, float],\tlow_pass_nfreqs: List[int] = [100, 500]):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.change_x_units": {"fullname": "ramanchada2.spectrum.calibration.change_x_units", "modulename": "ramanchada2.spectrum.calibration.change_x_units", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"fullname": "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1", "modulename": "ramanchada2.spectrum.calibration.change_x_units", "qualname": "abs_nm_to_shift_cm_1", "kind": "function", "doc": "Convert wavelength to Ramanshift in wavenumber
\n\nArguments:
\n\n\n- spe: internal use only
\n- laser_wave_length_nm: Laser wave length
\n
\n\nReturns: Corrected x-values
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tlaser_wave_length_nm: float):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"fullname": "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm", "modulename": "ramanchada2.spectrum.calibration.change_x_units", "qualname": "shift_cm_1_to_abs_nm", "kind": "function", "doc": "Convert Ramanshift in wavenumber to wavelength
\n\nArguments:
\n\n\n- spe: internal use only
\n- laser_wave_length_nm: Laser wave length
\n
\n\nReturns: Corrected x-values
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tlaser_wave_length_nm: float):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"fullname": "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter", "modulename": "ramanchada2.spectrum.calibration.change_x_units", "qualname": "abs_nm_to_shift_cm_1_filter", "kind": "function", "doc": "Convert wavelength to Ramanshift in wavenumber
\n\nArguments:
\n\n\n- spe: internal use only
\n- laser_wave_length_nm: Laser wave length
\n
\n\nReturns: Spectrum with corrected x-values
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tlaser_wave_length_nm: float):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"fullname": "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter", "modulename": "ramanchada2.spectrum.calibration.change_x_units", "qualname": "shift_cm_1_to_abs_nm_filter", "kind": "function", "doc": "Convert Ramanshift in wavenumber to wavelength
\n\nArguments:
\n\n\n- spe: internal use only
\n- laser_wave_length_nm: Laser wave length
\n
\n\nReturns: Spectrum with corrected x-values
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tlaser_wave_length_nm: float):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.normalize": {"fullname": "ramanchada2.spectrum.calibration.normalize", "modulename": "ramanchada2.spectrum.calibration.normalize", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.calibration.normalize.normalize": {"fullname": "ramanchada2.spectrum.calibration.normalize.normalize", "modulename": "ramanchada2.spectrum.calibration.normalize", "qualname": "normalize", "kind": "function", "doc": "Normalize the spectrum.
\n\nArguments:
\n\n\n- strategy: If
unity
: normalize to sum(y)
. If min_unity
: subtract the minimum and normalize to 'unity'. If\nunity_density
: normalize to \u03a3(y_i*\u0394x_i)
. If unity_area
: same as unity_density
. If minmax
: scale\namplitudes in range [0, 1]
. If 'L1' or 'L2': L1 or L2 norm without subtracting the pedestal. \n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tstrategy: Literal['unity', 'min_unity', 'unity_density', 'unity_area', 'minmax', 'L1', 'L2'] = 'minmax'):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.scale_xaxis": {"fullname": "ramanchada2.spectrum.calibration.scale_xaxis", "modulename": "ramanchada2.spectrum.calibration.scale_xaxis", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"fullname": "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear", "modulename": "ramanchada2.spectrum.calibration.scale_xaxis", "qualname": "scale_xaxis_linear", "kind": "function", "doc": "Scale x-axis using a factor.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- factor: Defaults to 1.\nMultiply x-axis values with
factor
\n- preserve_integral: optional. Defaults to False.\nIf True, preserves the integral in sence\n$\\sum y_{orig;\\,i}*{\\Delta x_{orig}}_i = \\sum y_{new;\\,i}*{\\Delta x_{new}}_i = $
\n
\n\nReturns: Corrected spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tfactor: float = 1,\tpreserve_integral: bool = False):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"fullname": "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun", "modulename": "ramanchada2.spectrum.calibration.scale_xaxis", "qualname": "scale_xaxis_fun", "kind": "function", "doc": "Apply arbitrary calibration function to the x-axis values.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- fun: function to be applied
\n- args: Additional arguments to the provided functions
\n
\n\nReturns: Corrected spectrum
\n\nRaises:
\n\n\n- ValueError: If the new x-values are not strictly monotonically increasing.
\n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tfun: Callable[[Union[int, numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]]]], float],\targs=[]):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.scale_yaxis": {"fullname": "ramanchada2.spectrum.calibration.scale_yaxis", "modulename": "ramanchada2.spectrum.calibration.scale_yaxis", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"fullname": "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear", "modulename": "ramanchada2.spectrum.calibration.scale_yaxis", "qualname": "scale_yaxis_linear", "kind": "function", "doc": "Scale y-axis values
\n\nThis function provides the same result as spe*const
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- factor optional. Defaults to 1.\nY-values scaling factor
\n
\n\nReturns: corrected spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\tfactor: float = 1):", "funcdef": "def"}, "ramanchada2.spectrum.calibration.set_new_xaxis": {"fullname": "ramanchada2.spectrum.calibration.set_new_xaxis", "modulename": "ramanchada2.spectrum.calibration.set_new_xaxis", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"fullname": "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis", "modulename": "ramanchada2.spectrum.calibration.set_new_xaxis", "qualname": "set_new_xaxis", "kind": "function", "doc": "Substitute x-axis values with new ones
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- xaxis: new x-axis values
\n
\n\nReturns: corrected spectrum
\n\nRaises:
\n\n\n- ValueError: If the provided array does not match the shape of the spectrum.
\n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\txaxis: numpy.ndarray[typing.Any, numpy.dtype[+_ScalarType_co]]):", "funcdef": "def"}, "ramanchada2.spectrum.creators": {"fullname": "ramanchada2.spectrum.creators", "modulename": "ramanchada2.spectrum.creators", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.creators.from_cache_or_calc": {"fullname": "ramanchada2.spectrum.creators.from_cache_or_calc", "modulename": "ramanchada2.spectrum.creators.from_cache_or_calc", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"fullname": "ramanchada2.spectrum.creators.from_cache_or_calc.logger", "modulename": "ramanchada2.spectrum.creators.from_cache_or_calc", "qualname": "logger", "kind": "variable", "doc": "\n", "default_value": "<Logger ramanchada2.spectrum.creators.from_cache_or_calc (WARNING)>"}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"fullname": "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc", "modulename": "ramanchada2.spectrum.creators.from_cache_or_calc", "qualname": "from_cache_or_calc", "kind": "function", "doc": "Load spectrum from cache or calculate if needed.
\n\nThe cache is a nested structure of spectra. All processings applied to\na spectrum result to spectra of the initial one. If part of the requred\nprocessings are available, only the needed steps are calculated and added\nto the cache.
\n\nArguments:
\n\n\n- required_steps: List of required steps in the form\n[{'proc': str, 'args': List[Any], 'kwargs': Dict[str, Any]}, ...]
\n- cachefile: optional. Defaults to None.\nFilename of the cache. If None no cache is used
\n
\n", "signature": "(\trequired_steps: ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel,\tcachefile: Optional[str] = None):", "funcdef": "def"}, "ramanchada2.spectrum.creators.from_chada": {"fullname": "ramanchada2.spectrum.creators.from_chada", "modulename": "ramanchada2.spectrum.creators.from_chada", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"fullname": "ramanchada2.spectrum.creators.from_chada.from_chada", "modulename": "ramanchada2.spectrum.creators.from_chada", "qualname": "from_chada", "kind": "function", "doc": "\n", "signature": "(filename: str, dataset: str = '/raw', h5module=None):", "funcdef": "def"}, "ramanchada2.spectrum.creators.from_delta_lines": {"fullname": "ramanchada2.spectrum.creators.from_delta_lines", "modulename": "ramanchada2.spectrum.creators.from_delta_lines", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"fullname": "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines", "modulename": "ramanchada2.spectrum.creators.from_delta_lines", "qualname": "from_delta_lines", "kind": "function", "doc": "Generate Spectrum
with delta lines.
\n\nArguments:
\n\n\n- deltas: Keys of the dictionary are the
x
positions of the deltas; values are the amplitudes of the corresponding\ndeltas. \n- xcal: Callable, optional.
x
axis calibration function. \n- nbins:
int
, optional. Number of bins in the spectrum. \n- xaxis:
Array-like
, optional. The xaxis of the new spectrum. If xaxis
is provided,\nxcal
should be None
and nbins
is ignored. \n
\n\nExample:
\n\nThis will produce spectrum with 1000 bins in the range [-1000, 2000)
:
\n\n\n
xcal = lambda x: x*3 -1000, nbins=1000\n
\n
\n", "signature": "(\tdeltas: Dict[float, float],\txcal: Optional[Callable[[float], float]] = None,\tnbins: typing.Annotated[int, Gt(gt=0)] = 2000,\txaxis: Optional[numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]]] = None,\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.creators.from_local_file": {"fullname": "ramanchada2.spectrum.creators.from_local_file", "modulename": "ramanchada2.spectrum.creators.from_local_file", "kind": "module", "doc": "Create spectrum from local files.
\n"}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"fullname": "ramanchada2.spectrum.creators.from_local_file.from_local_file", "modulename": "ramanchada2.spectrum.creators.from_local_file", "qualname": "from_local_file", "kind": "function", "doc": "Read experimental spectrum from a local file.
\n\nArguments:
\n\n\n- in_file_name: Path to a local file containing a spectrum.
\n- filetype: Specify the filetype. Filetype can be any of:
spc
, sp
, spa
, 0
, 1
, 2
, wdf
, ngs
, jdx
, dx
,\ntxt
, txtr
, csv
, prn
, rruf
, spe
(Princeton Instruments) or None
.\nNone
used to determine by extension of the file. \n- backend:
native
, rc1_parser
or None
. None
means both. \n
\n\nRaises:
\n\n\n- ValueError: When called with unsupported file formats.
\n
\n", "signature": "(\tin_file_name: str,\tfiletype: Optional[Literal['spc', 'sp', 'spa', '0', '1', '2', 'wdf', 'ngs', 'jdx', 'dx', 'txt', 'txtr', 'csv', 'prn', 'rruf', 'spe']] = None,\tbackend: Optional[Literal['native', 'rc1_parser']] = None):", "funcdef": "def"}, "ramanchada2.spectrum.creators.from_simulation": {"fullname": "ramanchada2.spectrum.creators.from_simulation", "modulename": "ramanchada2.spectrum.creators.from_simulation", "kind": "module", "doc": "Create spectrum from simulation output files.
\n"}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"fullname": "ramanchada2.spectrum.creators.from_simulation.from_simulation", "modulename": "ramanchada2.spectrum.creators.from_simulation", "qualname": "from_simulation", "kind": "function", "doc": "Generate spectrum from simulation file.
\n\nThe returned spectrum has only few x/y pairs -- one for each simulated line. Values along\nthe x-axis will not be uniform. To make it uniform, one needs to resample the spectrum.
\n\nArguments:
\n\n\n- in_file: Path to a local file, or file-like object.
\n- sim_type: If
vasp
: .dat
file from VASP simulation. If crystal_out
: .out
file from CRYSTAL simulation, not\npreferred. If crystal_dat
: .dat
file from CRYSTAL simulation. \n- use: One of the directions
I_tot
, I_perp
, I_par
, I_xx
, I_xy
,\nI_xz
, I_yy
, I_yz
, I_zz
, I_tot
, I_perp
, I_par
are\navailable for both CRYSTAL and VASP. I_xx
, I_xy
, I_xz
,\nI_yy
, I_yz
, I_zz
are available only for CRYSTAL. If a Dict is\npassed, the key should be directions and values should be weighting factor.\nFor example, use={'I_perp': .1, 'I_par': .9}
\n
\n", "signature": "(\tin_file: Union[str, io.TextIOBase],\tsim_type: Literal['vasp', 'crystal_out', 'crystal_dat', 'raw_dat'],\tuse: Union[Literal['I_tot', 'I_perp', 'I_par', 'I_xx', 'I_xy', 'I_xz', 'I_yy', 'I_yz', 'I_zz'], Dict[Literal['I_tot', 'I_perp', 'I_par', 'I_xx', 'I_xy', 'I_xz', 'I_yy', 'I_yz', 'I_zz'], Annotated[float, Gt(gt=0)]]] = 'I_tot',\tnbins: typing.Annotated[int, Gt(gt=0)] = 2000):", "funcdef": "def"}, "ramanchada2.spectrum.creators.from_spectral_component_collection": {"fullname": "ramanchada2.spectrum.creators.from_spectral_component_collection", "modulename": "ramanchada2.spectrum.creators.from_spectral_component_collection", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"fullname": "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection", "modulename": "ramanchada2.spectrum.creators.from_spectral_component_collection", "qualname": "from_spectral_component_collection", "kind": "function", "doc": "from_spectral_component_collection
\n\nArguments:
\n\n\n- spe_components: SpectralComponentCollection
\n- x:
int
or array-like, optional, default 2000
. x
axis of the spectrum. \n
\n", "signature": "(\tspe_components: ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection,\tx=2000):", "funcdef": "def"}, "ramanchada2.spectrum.creators.from_stream": {"fullname": "ramanchada2.spectrum.creators.from_stream", "modulename": "ramanchada2.spectrum.creators.from_stream", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"fullname": "ramanchada2.spectrum.creators.from_stream.from_stream", "modulename": "ramanchada2.spectrum.creators.from_stream", "qualname": "from_stream", "kind": "function", "doc": "\n", "signature": "(\tin_stream: Union[io.TextIOBase, _io.BytesIO, _io.BufferedReader],\tfiletype: Optional[Literal['spc', 'sp', 'spa', '0', '1', '2', 'wdf', 'ngs', 'jdx', 'dx', 'txt', 'txtr', 'csv', 'prn', 'rruf', 'spe']],\tfilename: Optional[str] = None,\tbackend: Optional[Literal['native', 'rc1_parser']] = None):", "funcdef": "def"}, "ramanchada2.spectrum.creators.from_test_spe": {"fullname": "ramanchada2.spectrum.creators.from_test_spe", "modulename": "ramanchada2.spectrum.creators.from_test_spe", "kind": "module", "doc": "Create spectrum from local files.
\n"}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"fullname": "ramanchada2.spectrum.creators.from_test_spe.from_test_spe", "modulename": "ramanchada2.spectrum.creators.from_test_spe", "qualname": "from_test_spe", "kind": "function", "doc": "Create new spectrum from test data.
\n\nArguments:
\n\n\n- index:
int
or None
, optional, default is None
. If int
: will be used as an index of filtered list. If\nNone
: a random spectrum will be taken. \n- **kwargs: The rest of the parameters will be used as filter.
\n
\n", "signature": "(index=None, **kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.creators.from_theoretical_lines": {"fullname": "ramanchada2.spectrum.creators.from_theoretical_lines", "modulename": "ramanchada2.spectrum.creators.from_theoretical_lines", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"fullname": "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines", "modulename": "ramanchada2.spectrum.creators.from_theoretical_lines", "qualname": "from_theoretical_lines", "kind": "function", "doc": "Generate spectrum from lmfit
shapes.
\n\nArguments:
\n\n\n- shapes: The shapes to be used for spectrum generation.
\n- params: Shape parameters to be applied to be used with shapes.
\n- x: Array with
x
values, by default np.array(2000)
. \n
\n", "signature": "(\tshapes: List[Literal['gaussian', 'gaussian2d', 'lorentzian', 'voigt', 'pvoigt', 'moffat', 'pearson4', 'pearson7', 'breit_wigner', 'damped_oscillator', 'dho', 'logistic', 'lognormal', 'students_t', 'expgaussian', 'doniach', 'skewed_gaussian', 'skewed_voigt', 'thermal_distribution', 'step', 'rectangle', 'exponential', 'powerlaw', 'linear', 'parabolic', 'sine', 'expsine', 'split_lorentzian']],\tparams: List[Dict],\tx: Union[int, numpy.ndarray[Any, numpy.dtype[numpy.float64]]] = 2000):", "funcdef": "def"}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure": {"fullname": "ramanchada2.spectrum.creators.hdr_from_multi_exposure", "modulename": "ramanchada2.spectrum.creators.hdr_from_multi_exposure", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"fullname": "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure", "modulename": "ramanchada2.spectrum.creators.hdr_from_multi_exposure", "qualname": "hdr_from_multi_exposure", "kind": "function", "doc": "Create an HDR spectrum from several spectra with different exposures.
\n\nThe resulting spectrum will have the details in low-intensity peaks\nfrom long-exposure-time spectrum. As long-exposure-time\nspectrum might be sturated, the information for high-intensity\npeaks will be taken from short-exposure-time spectrum.\nThis function will work on a very limited number of spectra,\nbecause we still do not have standardized metadata.
\n", "signature": "(spes_in: List[ramanchada2.spectrum.spectrum.Spectrum]):", "funcdef": "def"}, "ramanchada2.spectrum.filters": {"fullname": "ramanchada2.spectrum.filters", "modulename": "ramanchada2.spectrum.filters", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.add_gaussian_noise": {"fullname": "ramanchada2.spectrum.filters.add_gaussian_noise", "modulename": "ramanchada2.spectrum.filters.add_gaussian_noise", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"fullname": "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise", "modulename": "ramanchada2.spectrum.filters.add_gaussian_noise", "qualname": "add_gaussian_noise", "kind": "function", "doc": "Add gaussian noise to the spectrum.
\n\nRandom number i.i.d. $N(0, \\sigma)$ is added to every sample
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- sigma: Sigma of the gaussian noise.
\n- rng_seed:
int
or rng state, optional, seed for the random generator.\nIf a state is provided, it is updated in-place. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tsigma: typing.Annotated[float, Gt(gt=0)],\trng_seed=None):", "funcdef": "def"}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift": {"fullname": "ramanchada2.spectrum.filters.add_gaussian_noise_drift", "modulename": "ramanchada2.spectrum.filters.add_gaussian_noise_drift", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"fullname": "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift", "modulename": "ramanchada2.spectrum.filters.add_gaussian_noise_drift", "qualname": "generate_add_gaussian_noise_drift", "kind": "function", "doc": "\n", "signature": "(\ty,\t/,\tsigma: typing.Annotated[float, Gt(gt=0)],\tcoef: typing.Annotated[float, None, Interval(gt=None, ge=0, lt=None, le=1), None, None],\trng_seed=None):", "funcdef": "def"}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"fullname": "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift", "modulename": "ramanchada2.spectrum.filters.add_gaussian_noise_drift", "qualname": "add_gaussian_noise_drift", "kind": "function", "doc": "Add cumulative gaussian noise to the spectrum.
\n\nExponential-moving-average-like gaussian noise is added\nto each sample. The goal is to mimic the low-frequency noise\n(or random substructures in spectra).\nThe additive noise is\n$$a_i = coef*\\sum_{j=0}^{i-1}g_j + g_i,$$
\n\nwhere\n$$g_i = \\mathcal{N}(0, 1+\\frac{coef}{\\sqrt 2}).$$
\n\nThis way drifting is possible while keeping the\n$$\\sigma(\\Delta(a)) \\approx 1.$$
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- sigma: Sigma of the gaussian noise.
\n- coef:
float
in [0, 1]
, drifting coefficient. If coef == 0
,\nthe result is identical to add_gaussian_noise()
. \n- rng_seed:
int
or rng state, optional. Seed for the random generator.\nIf a state is provided, it is updated in-place. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tsigma: typing.Annotated[float, Gt(gt=0)],\tcoef: typing.Annotated[float, None, Interval(gt=None, ge=0, lt=None, le=1), None, None],\trng_seed=None):", "funcdef": "def"}, "ramanchada2.spectrum.filters.add_poisson_noise": {"fullname": "ramanchada2.spectrum.filters.add_poisson_noise", "modulename": "ramanchada2.spectrum.filters.add_poisson_noise", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"fullname": "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise", "modulename": "ramanchada2.spectrum.filters.add_poisson_noise", "qualname": "add_poisson_noise", "kind": "function", "doc": "Add poisson noise to the spectrum.
\n\nFor each particular sample the noise is proportional to $\\sqrt{scale*a_i}$.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- scale:
float
, optional, default is 1
. Scale the amplitude of the noise. \n- rng_seed:
int
or rng state, optional. Seed for the random generator.\nIf a state is provided, it is updated in-place. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tscale: float = 1,\trng_seed=None):", "funcdef": "def"}, "ramanchada2.spectrum.filters.convolve": {"fullname": "ramanchada2.spectrum.filters.convolve", "modulename": "ramanchada2.spectrum.filters.convolve", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.convolve.convolve": {"fullname": "ramanchada2.spectrum.filters.convolve.convolve", "modulename": "ramanchada2.spectrum.filters.convolve", "qualname": "convolve", "kind": "function", "doc": "Convole spectrum with arbitrary lineshape.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- lineshape: callable,
str
or np.ndarray
.\n If callable: should have a single positional argument x
, e.g.\nlambda x: np.exp((x/5)**2)
.\nIf predefined peak profile: can be gaussian
, lorentzian
, voigt
,\npvoigt
, moffat
or pearson4
.\nIf np.ndarray
: lineshape in samples. \n- **kwargs: Additional kwargs will be passed to lineshape function.
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tlineshape: Union[Callable[[Union[float, numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]]]], float], numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], Literal['gaussian', 'lorentzian', 'voigt', 'pvoigt', 'moffat', 'pearson4', 'pearson7']],\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.filters.drop_spikes": {"fullname": "ramanchada2.spectrum.filters.drop_spikes", "modulename": "ramanchada2.spectrum.filters.drop_spikes", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"fullname": "ramanchada2.spectrum.filters.drop_spikes.spike_indices", "modulename": "ramanchada2.spectrum.filters.drop_spikes", "qualname": "spike_indices", "kind": "function", "doc": "Find spikes in spectrum
\n\nSingle-bin spikes are located using left and right successive\ndifferences. The threshold is based on the standart deviation\nof the metric which makes this algorithm less optimal.
\n\nArguments:
\n\n\n- spe: internal use only
\n- n_sigma: Threshold value should be
n_sigma
times the standart\ndeviation of the metric. \n
\n\nReturns: List of spike indices
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_sigma: typing.Annotated[float, Gt(gt=0)]) -> numpy.ndarray[typing.Any, numpy.dtype[+_ScalarType_co]]:", "funcdef": "def"}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"fullname": "ramanchada2.spectrum.filters.drop_spikes.drop_spikes", "modulename": "ramanchada2.spectrum.filters.drop_spikes", "qualname": "drop_spikes", "kind": "function", "doc": "Removes single-bin spikes.
\n\nRemove x, y pairs recognised as spikes using left and right\nsuccessive differences and standard-deviation-based threshold.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- n_sigma: optional, default is
10
.\nThreshold is n_sigma
times the standard deviation. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_sigma: typing.Annotated[float, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"fullname": "ramanchada2.spectrum.filters.drop_spikes.recover_spikes", "modulename": "ramanchada2.spectrum.filters.drop_spikes", "qualname": "recover_spikes", "kind": "function", "doc": "Recover single-bin spikes.
\n\nRecover x, y pairs recognised as spikes using left and right\nsuccessive differences and standard-deviation-based threshold\nand linear interpolation.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- n_sigma: optional, default is
10
.\nThreshold is n_sigma
times the standard deviation. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_sigma: typing.Annotated[float, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"fullname": "ramanchada2.spectrum.filters.drop_spikes.get_spikes", "modulename": "ramanchada2.spectrum.filters.drop_spikes", "qualname": "get_spikes", "kind": "function", "doc": "Get single-bin spikes only.
\n\nGet x, y pairs recognised as spikes using left and right\nsuccessive differences and standard-deviation-based threshold\nand linear interpolation.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- n_sigma: optional, default is
10
.\nThreshold is n_sigma
times the standard deviation. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_sigma: typing.Annotated[float, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.filters.dropna": {"fullname": "ramanchada2.spectrum.filters.dropna", "modulename": "ramanchada2.spectrum.filters.dropna", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.dropna.dropna": {"fullname": "ramanchada2.spectrum.filters.dropna.dropna", "modulename": "ramanchada2.spectrum.filters.dropna", "qualname": "dropna", "kind": "function", "doc": "Remove non finite numbers on both axes
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum):", "funcdef": "def"}, "ramanchada2.spectrum.filters.moving_average": {"fullname": "ramanchada2.spectrum.filters.moving_average", "modulename": "ramanchada2.spectrum.filters.moving_average", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"fullname": "ramanchada2.spectrum.filters.moving_average.moving_average", "modulename": "ramanchada2.spectrum.filters.moving_average", "qualname": "moving_average", "kind": "function", "doc": "Moving average filter.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- window_size:
int
, optional, default is 10
. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\twindow_size: typing.Annotated[int, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"fullname": "ramanchada2.spectrum.filters.moving_average.moving_average_convolve", "modulename": "ramanchada2.spectrum.filters.moving_average", "qualname": "moving_average_convolve", "kind": "function", "doc": "Moving average filter.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- window_size:
int
, optional, default is 10
. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\twindow_size: typing.Annotated[int, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.filters.moving_median": {"fullname": "ramanchada2.spectrum.filters.moving_median", "modulename": "ramanchada2.spectrum.filters.moving_median", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"fullname": "ramanchada2.spectrum.filters.moving_median.moving_median", "modulename": "ramanchada2.spectrum.filters.moving_median", "qualname": "moving_median", "kind": "function", "doc": "Moving median filter.
\n\nThe resultant spectrum is moving minimum of the input.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- window_size:
int
, optional, default is 10
. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\twindow_size: typing.Annotated[int, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"fullname": "ramanchada2.spectrum.filters.moving_median.subtract_moving_median", "modulename": "ramanchada2.spectrum.filters.moving_median", "qualname": "subtract_moving_median", "kind": "function", "doc": "Subtract moving median filter.
\n\nThe resultant spectrum is moving minimum of the input subtracted from the input.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- window_size:
int
, optional, default is 10
. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\twindow_size: int):", "funcdef": "def"}, "ramanchada2.spectrum.filters.pad_zeros": {"fullname": "ramanchada2.spectrum.filters.pad_zeros", "modulename": "ramanchada2.spectrum.filters.pad_zeros", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"fullname": "ramanchada2.spectrum.filters.pad_zeros.pad_zeros", "modulename": "ramanchada2.spectrum.filters.pad_zeros", "qualname": "pad_zeros", "kind": "function", "doc": "Extend x-axis by 100% in both directions.
\n\nThe x-axis of resultant spectrum will be:\n$[x_{lower}-(x_{upper}-x_{lower})..(x_{upper}+(x_{upper}-x_{lower}))]$.\nThe length of the new spectrum is 3 times the original. The added values\nare with an uniform step. In the middle is the original spectrum with\noriginal x and y values. The coresponding y vallues for the newly added\nx-values are always zeros.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/):", "funcdef": "def"}, "ramanchada2.spectrum.filters.resampling": {"fullname": "ramanchada2.spectrum.filters.resampling", "modulename": "ramanchada2.spectrum.filters.resampling", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"fullname": "ramanchada2.spectrum.filters.resampling.resample_NUDFT", "modulename": "ramanchada2.spectrum.filters.resampling", "qualname": "resample_NUDFT", "kind": "function", "doc": "Resample the spectrum using Non-uniform discrete fourier transform.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with NUDFT and inverse FFT.
\n\nArguments:
\n\n\n- spe: internal use only
\n- x_range: optional. Defaults to (0, 4000).\nThe x_range of the new spectrum.
\n- xnew_bins: optional. Defaults to 100.\nNumber of bins of the new spectrum
\n- window: optional, Defaults to None.\nThe window to be used for lowpass filter. If None 'blackmanharris' is used.\nIf no low-pass filter is required, one can use
window=lambda x: [1]*len(x)
. \n- cumulative: optional. Defaults to False.\nIf True, the resultant spectrum will be cumulative and normalized\n(in analogy with CDF).
\n
\n\nReturns:
\n\n\n (x_values, y_values)
\n
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tx_range: Tuple[float, float] = (0, 4000),\txnew_bins: typing.Annotated[int, Gt(gt=0)] = 100,\twindow: Union[Callable, Tuple[Any, ...], Literal['barthann', 'bartlett', 'blackman', 'blackmanharris', 'bohman', 'boxcar', 'chebwin', 'cosine', 'dpss', 'exponential', 'flattop', 'gaussian', 'general_cosine', 'general_gaussian', 'general_hamming', 'hamming', 'hann', 'kaiser', 'nuttall', 'parzen', 'taylor', 'triang', 'tukey'], NoneType] = None,\tcumulative: bool = False):", "funcdef": "def"}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"fullname": "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter", "modulename": "ramanchada2.spectrum.filters.resampling", "qualname": "resample_NUDFT_filter", "kind": "function", "doc": "Resample the spectrum using Non-uniform discrete fourier transform.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with NUDFT and inverse FFT.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- x_range: optional. Defaults to (0, 4000).\nThe x_range of the new spectrum.
\n- xnew_bins: optional. Defaults to 100.\nNumber of bins of the new spectrum
\n- window: optional, Defaults to None.\nThe window to be used for lowpass filter. If None 'blackmanharris' is used.\nIf no low-pass filter is required, one can use
window=lambda x: [1]*len(x)
. \n- cumulative: optional. Defaults to False.\nIf True, the resultant spectrum will be cumulative and normalized\n(in analogy with CDF).
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tx_range: Tuple[float, float] = (0, 4000),\txnew_bins: typing.Annotated[int, Gt(gt=0)] = 100,\twindow=None,\tcumulative: bool = False):", "funcdef": "def"}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"fullname": "ramanchada2.spectrum.filters.resampling.resample_spline", "modulename": "ramanchada2.spectrum.filters.resampling", "qualname": "resample_spline", "kind": "function", "doc": "Resample the spectrum using spline interpolation.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with spline interpolation.
\n\nArguments:
\n\n\n- spe: internal use only
\n- x_range: optional. Defaults to (0, 4000).\nThe x_range of the new spectrum.
\n- xnew_bins: optional. Defaults to 100.\nNumber of bins of the new spectrum
\n- spline: optional, Defaults to 'pchip'.\nName of the spline funcion to be used.
\n- cumulative: optional. Defaults to False.\nIf True, the resultant spectrum will be cumulative and normalized\n(in analogy with CDF).
\n
\n\nReturns:
\n\n\n (x_values, y_values)
\n
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tx_range: Tuple[float, float] = (0, 4000),\txnew_bins: typing.Annotated[int, Gt(gt=0)] = 100,\tspline: Literal['pchip', 'akima', 'makima', 'cubic_spline'] = 'pchip',\tinterp_kw_args: Optional[Dict] = None,\tcumulative: bool = False):", "funcdef": "def"}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"fullname": "ramanchada2.spectrum.filters.resampling.resample_spline_filter", "modulename": "ramanchada2.spectrum.filters.resampling", "qualname": "resample_spline_filter", "kind": "function", "doc": "Resample the spectrum using spline interpolation.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with spline interpolation.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- x_range: optional. Defaults to (0, 4000).\nThe x_range of the new spectrum.
\n- xnew_bins: optional. Defaults to 100.\nNumber of bins of the new spectrum
\n- spline: optional, Defaults to 'pchip'.\nName of the spline funcion to be used.
\n- cumulative: optional. Defaults to False.\nIf True, the resultant spectrum will be cumulative and normalized\n(in analogy with CDF).
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tx_range: Tuple[float, float] = (0, 4000),\txnew_bins: typing.Annotated[int, Gt(gt=0)] = 100,\tspline: Literal['pchip', 'akima', 'makima', 'cubic_spline'] = 'pchip',\tinterp_kw_args: Optional[Dict] = None,\tcumulative: bool = False):", "funcdef": "def"}, "ramanchada2.spectrum.filters.sharpen_lines": {"fullname": "ramanchada2.spectrum.filters.sharpen_lines", "modulename": "ramanchada2.spectrum.filters.sharpen_lines", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"fullname": "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening", "modulename": "ramanchada2.spectrum.filters.sharpen_lines", "qualname": "derivative_sharpening", "kind": "function", "doc": "Derivative-based sharpening.
\n\nSharpen the spectrum subtracting second derivative and add fourth derivative.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- filter_fraction
float
in (0; 1]: Default is 0.6\nDepth of filtration \n- signal_width: The width of features to be enhanced in sample count
\n- der2_factor: Second derivative scaling factor
\n- der4_factor: Fourth derivative scaling factor
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tfilter_fraction: typing.Annotated[float, None, Interval(gt=0, ge=None, lt=None, le=1), None, None] = 0.6,\tsig_width: typing.Annotated[float, None, Interval(gt=None, ge=0, lt=None, le=None), None, None] = 0.25,\tder2_factor: float = 1,\tder4_factor: float = 0.1):", "funcdef": "def"}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"fullname": "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening", "modulename": "ramanchada2.spectrum.filters.sharpen_lines", "qualname": "hht_sharpening", "kind": "function", "doc": "Hilbert-Huang based sharpening.
\n\nIn order to reduce the overshooting, moving minimum is subtracted from the result
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- movmin: optional. Default is 100\nWindow size for moving minimum
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tmovmin=100):", "funcdef": "def"}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"fullname": "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain", "modulename": "ramanchada2.spectrum.filters.sharpen_lines", "qualname": "hht_sharpening_chain", "kind": "function", "doc": "Hilbert-Huang based chain sharpening.
\n\nSequence of Hilbert-Huang sharpening procedures are performed.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- movmin: List[int], optional. Default is [150, 50]\nThe numer of values in the list defines how many iterations\nof HHT_sharpening will be performed and the values define\nthe moving minimum window sizes for the corresponding operations.
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tmovmin: List[Annotated[int, Gt(gt=0)]] = [150, 50]):", "funcdef": "def"}, "ramanchada2.spectrum.filters.smoothing": {"fullname": "ramanchada2.spectrum.filters.smoothing", "modulename": "ramanchada2.spectrum.filters.smoothing", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"fullname": "ramanchada2.spectrum.filters.smoothing.smoothing_RC1", "modulename": "ramanchada2.spectrum.filters.smoothing", "qualname": "smoothing_RC1", "kind": "function", "doc": "Smooth the spectrum.
\n\nThe spectrum will be smoothed using the specified filter.\nThis method is inherited from ramanchada1 for compatibility reasons.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- method: method to be used
\n- **kwargs: keyword arguments to be passed to the selected method
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*args,\tmethod: Literal['savgol', 'sg', 'wiener', 'median', 'gauss', 'gaussian', 'lowess', 'boxcar'],\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.filters.trim_axes": {"fullname": "ramanchada2.spectrum.filters.trim_axes", "modulename": "ramanchada2.spectrum.filters.trim_axes", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"fullname": "ramanchada2.spectrum.filters.trim_axes.trim_axes", "modulename": "ramanchada2.spectrum.filters.trim_axes", "qualname": "trim_axes", "kind": "function", "doc": "Trim axes of the spectrum.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- method: 'x-axis' or 'bins'\nIf 'x-axis' boundaries will be interpreted as x-axis values.\nIf 'bins' boundaries will be interpreted as indices.
\n- boundaries: lower and upper boundary for the trimming.
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tmethod: Literal['x-axis', 'bins'],\tboundaries: Tuple[float, float]):", "funcdef": "def"}, "ramanchada2.spectrum.peaks": {"fullname": "ramanchada2.spectrum.peaks", "modulename": "ramanchada2.spectrum.peaks", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.peaks.find_peaks": {"fullname": "ramanchada2.spectrum.peaks.find_peaks", "modulename": "ramanchada2.spectrum.peaks.find_peaks", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"fullname": "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries", "modulename": "ramanchada2.spectrum.peaks.find_peaks", "qualname": "peak_boundaries", "kind": "function", "doc": "\n", "signature": "(spe, wlen, width, prominence):", "funcdef": "def"}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"fullname": "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak", "modulename": "ramanchada2.spectrum.peaks.find_peaks", "qualname": "find_peak_multipeak", "kind": "function", "doc": "Find groups of peaks in spectrum.
\n\nArguments:
\n\n\n- spe: internal use only
\n- prominence: Optional. Defaults to None\nIf None the prominence value will be
spe.y_nose
. Reasonable value for\npromience is const * spe.y_noise_MAD
. \n- wlen: optional. Defaults to None.\nwlen value used in
scipy.signal.find_peaks
. If wlen is None, 200 will be used. \n- width: optional. Defaults to None.\nwidth value used in
scipy.signal.find_peaks
. If width is None, 2 will be used. \n- hht_chain: optional. Defaults to None.\nList of hht_chain window sizes. If None, no hht sharpening is performed.
\n- bgm_kwargs: kwargs for bayesian_gaussian_mixture
\n- sharpening 'hht' or None. Defaults to None.\nIf 'hht' hht sharpening will be performed before finding peaks.
\n- strategy: optional. Defauts to 'topo'.\nPeakfinding method
\n
\n\nReturns:
\n\n\n ListPeakCandidateMultiModel: Located peak groups
\n
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tprominence: Optional[Annotated[float, Ge(ge=0)]] = None,\twlen: Optional[Annotated[int, Ge(ge=0)]] = None,\twidth: Union[int, Tuple[int, int], NoneType] = None,\thht_chain: Optional[List[Annotated[int, Gt(gt=0)]]] = None,\tbgm_kwargs={},\tsharpening: Optional[Literal['hht']] = None,\tstrategy: Literal['topo', 'bayesian_gaussian_mixture', 'bgm', 'cwt'] = 'topo') -> ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel:", "funcdef": "def"}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"fullname": "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter", "modulename": "ramanchada2.spectrum.peaks.find_peaks", "qualname": "find_peak_multipeak_filter", "kind": "function", "doc": "Same as find_peak_multipeak
but the result is stored as metadata in the returned spectrum.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- args, *kwargs: same as
find_peak_multipeak
\n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*args,\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture": {"fullname": "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture", "modulename": "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"fullname": "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture", "modulename": "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture", "qualname": "bayesian_gaussian_mixture", "kind": "function", "doc": "Decompose the spectrum to Bayesian Gaussian Mixture
\n\nArguments:
\n\n\n- spe: internal use only
\n- n_samples: optional. Defaults to 5000.\nResampled dataset size
\n- n_components: optional. Defaults to 50.\nNumber of expected gaussian components
\n- max_iter: optional. Defaults to 100.\nMaximal number of iterations.
\n- moving_minimum_window: optional. Defaults to None.\nIf None no moving minimum is subtracted, otherwise as specified.
\n- random_state: optional. Defaults to None.\nRandom generator seed to be used.
\n- trim_range: optional. Defaults to None:\nIf None ignore trimming, otherwise trim range is in x-axis values.
\n
\n\nReturns:
\n\n\n BayesianGaussianMixture: Fitted Bayesian Gaussian Mixture
\n
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_samples: typing.Annotated[int, Gt(gt=0)] = 5000,\tn_components: typing.Annotated[int, Gt(gt=0)] = 50,\tmax_iter: typing.Annotated[int, Gt(gt=0)] = 100,\tmoving_minimum_window: Optional[Annotated[int, Gt(gt=0)]] = None,\trandom_state=None,\ttrim_range: Optional[Tuple[float, float]] = None) -> sklearn.mixture._bayesian_mixture.BayesianGaussianMixture:", "funcdef": "def"}, "ramanchada2.spectrum.peaks.fit_peaks": {"fullname": "ramanchada2.spectrum.peaks.fit_peaks", "modulename": "ramanchada2.spectrum.peaks.fit_peaks", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"fullname": "ramanchada2.spectrum.peaks.fit_peaks.logger", "modulename": "ramanchada2.spectrum.peaks.fit_peaks", "qualname": "logger", "kind": "variable", "doc": "\n", "default_value": "<Logger ramanchada2.spectrum.peaks.fit_peaks (WARNING)>"}, "ramanchada2.spectrum.peaks.fit_peaks.available_models": {"fullname": "ramanchada2.spectrum.peaks.fit_peaks.available_models", "modulename": "ramanchada2.spectrum.peaks.fit_peaks", "qualname": "available_models", "kind": "variable", "doc": "\n", "default_value": "['Gaussian', 'Lorentzian', 'Moffat', 'Voigt', 'PseudoVoigt', 'Pearson4', 'Pearson7']"}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"fullname": "ramanchada2.spectrum.peaks.fit_peaks.available_models_type", "modulename": "ramanchada2.spectrum.peaks.fit_peaks", "qualname": "available_models_type", "kind": "variable", "doc": "\n", "default_value": "typing.Literal['Gaussian', 'Lorentzian', 'Moffat', 'Voigt', 'PseudoVoigt', 'Pearson4', 'Pearson7']"}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"fullname": "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params", "modulename": "ramanchada2.spectrum.peaks.fit_peaks", "qualname": "build_multipeak_model_params", "kind": "function", "doc": "\n", "signature": "(\tprofile: Union[Literal['Gaussian', 'Lorentzian', 'Moffat', 'Voigt', 'PseudoVoigt', 'Pearson4', 'Pearson7'], List[Literal['Gaussian', 'Lorentzian', 'Moffat', 'Voigt', 'PseudoVoigt', 'Pearson4', 'Pearson7']]],\tcandidates: ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel,\tbaseline_model: Literal['linear', None] = 'linear'):", "funcdef": "def"}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"fullname": "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel", "modulename": "ramanchada2.spectrum.peaks.fit_peaks", "qualname": "fit_peak_multimodel", "kind": "function", "doc": "\n", "signature": "(\tspe,\t/,\t*,\tprofile: Union[Literal['Gaussian', 'Lorentzian', 'Moffat', 'Voigt', 'PseudoVoigt', 'Pearson4', 'Pearson7'], List[Literal['Gaussian', 'Lorentzian', 'Moffat', 'Voigt', 'PseudoVoigt', 'Pearson4', 'Pearson7']]],\tcandidates: ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel,\tno_fit=False,\tshould_break=[False],\tkwargs_fit={},\tvary_baseline: bool = False,\tbound_centers_to_group: bool = False) -> ramanchada2.misc.types.fit_peaks_result.FitPeaksResult:", "funcdef": "def"}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"fullname": "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter", "modulename": "ramanchada2.spectrum.peaks.fit_peaks", "qualname": "fit_peaks_filter", "kind": "function", "doc": "Same as fit_peak_multipeak
but the result is stored as metadata in the returned spectrum.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- should_break: same as in fit_peaks_multipeak
\n- args, *kwargs: same as
fit_peaks_multipeak
\n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*args,\tshould_break=[False],\tkwargs_fit={},\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.peaks.get_fitted_peaks": {"fullname": "ramanchada2.spectrum.peaks.get_fitted_peaks", "modulename": "ramanchada2.spectrum.peaks.get_fitted_peaks", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"fullname": "ramanchada2.spectrum.peaks.get_fitted_peaks.logger", "modulename": "ramanchada2.spectrum.peaks.get_fitted_peaks", "qualname": "logger", "kind": "variable", "doc": "\n", "default_value": "<Logger ramanchada2.spectrum.peaks.get_fitted_peaks (WARNING)>"}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"fullname": "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions", "modulename": "ramanchada2.spectrum.peaks.get_fitted_peaks", "qualname": "fit_peak_positions", "kind": "function", "doc": "Calculate peak positions and amplitudes.
\n\nSequence of multiple processings:
\n\n\nsubtract_moving_minimum
\nfind_peak_multipeak
\n- filter peaks with x-location better than threshold
\n
\n\nArguments:
\n\n\n- spe: internal use only
\n- mov_min: optional. Defaults to 40\nsubtract moving_minimum with the specified window.
\n- center_err_threshold: optional. Defaults to 0.5.\nthreshold for centroid standard deviation. Only peaks\nwith better uncertainty will be returned.
\n- find_peaks_kw: optional\nkeyword arguments to be used with find_peak_multipeak
\n- fit_peaks_kw: optional\nkeyword arguments to be used with fit_peaks_multipeak
\n
\n\nReturns:
\n\n\n Dict[float, float]: {positions: amplitudes}
\n
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*,\tmov_min=40,\tcenter_err_threshold=0.5,\tfind_peaks_kw={},\tfit_peaks_kw={}) -> Dict[float, float]:", "funcdef": "def"}, "ramanchada2.spectrum.spectrum": {"fullname": "ramanchada2.spectrum.spectrum", "modulename": "ramanchada2.spectrum.spectrum", "kind": "module", "doc": "\n"}, "ramanchada2.spectrum.spectrum.logger": {"fullname": "ramanchada2.spectrum.spectrum.logger", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "logger", "kind": "variable", "doc": "\n", "default_value": "<Logger ramanchada2.spectrum.spectrum (WARNING)>"}, "ramanchada2.spectrum.spectrum.Spectrum": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum", "kind": "class", "doc": "Helper class that provides a standard way to create an ABC using\ninheritance.
\n", "bases": "ramanchada2.misc.plottable.Plottable"}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.__init__", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.__init__", "kind": "function", "doc": "\n", "signature": "(\tx: Union[numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], int, NoneType] = None,\ty: Optional[numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]]] = None,\tcachefile: Optional[str] = None,\tmetadata: Optional[ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel] = None,\tapplied_processings: Optional[ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel] = None)"}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.applied_processings_dict", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.write_csv", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.write_csv", "kind": "function", "doc": "\n", "signature": "(self, filename, delimiter=',', newline='\\n'):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.write_cha", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.write_cha", "kind": "function", "doc": "\n", "signature": "(self, chafile, dataset):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.write_nexus", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.write_nexus", "kind": "function", "doc": "\n", "signature": "(self, chafile, dataset):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.write_cache", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.write_cache", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.process", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.process", "kind": "function", "doc": "\n", "signature": "(self, algorithm: str, **kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.apply_creator", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.apply_creator", "kind": "function", "doc": "\n", "signature": "(\tcls,\tstep: ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel,\tcachefile_=None):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.apply_processing", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.apply_processing", "kind": "function", "doc": "\n", "signature": "(\tself,\tstep: ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.x": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.x", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.x", "kind": "variable", "doc": "\n"}, "ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.x_bin_boundaries", "kind": "variable", "doc": "\n"}, "ramanchada2.spectrum.spectrum.Spectrum.y": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.y", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.y", "kind": "variable", "doc": "\n", "annotation": ": numpy.ndarray[typing.Any, numpy.dtype[numpy.float64]]"}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.y_noise", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.y_noise", "kind": "variable", "doc": "\n"}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.y_noise_MAD", "kind": "function", "doc": "\n", "signature": "(self):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.y_noise_savgol_DL", "kind": "function", "doc": "\n", "signature": "(self, order: typing.Annotated[int, Gt(gt=0)] = 1):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.y_noise_savgol", "kind": "function", "doc": "\n", "signature": "(self, order: typing.Annotated[int, Gt(gt=0)] = 1):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.x_err": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.x_err", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.x_err", "kind": "variable", "doc": "\n"}, "ramanchada2.spectrum.spectrum.Spectrum.y_err": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.y_err", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.y_err", "kind": "variable", "doc": "\n"}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.meta", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.meta", "kind": "variable", "doc": "\n", "annotation": ": ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel"}, "ramanchada2.spectrum.spectrum.Spectrum.result": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.result", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.result", "kind": "variable", "doc": "\n"}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.spe_distribution", "kind": "function", "doc": "\n", "signature": "(self, trim_range: Optional[Tuple[float, float]] = None):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.gen_samples", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.gen_samples", "kind": "function", "doc": "\n", "signature": "(self, size: typing.Annotated[int, Gt(gt=0)], trim_range=None):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.moving_minimum", "kind": "function", "doc": "Moving minimum baseline estimator.\nSuccessive values are calculated as minima of rolling rectangular window.
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\twindow_size: int):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.subtract_moving_minimum", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\twindow_size: int):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.subtract_baseline_rc1_als", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\tlam=100000.0,\tp=0.001,\tniter=100,\tsmooth=7):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.subtract_baseline_rc1_snip", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\tniter=30):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.add_baseline", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.add_baseline", "kind": "function", "doc": "Add artificial baseline to the spectrum.\nA random baseline is generated in frequency domain using uniform random numbers.\nThe baseline in frequency domain is tapered with bohman window to reduce the bandwidth\nof the baseline to first n_freq
frequencies and is transformed to \"time\" domain.\nAdditionaly by using func
parameter the user can define arbitrary function\nto be added as baseline.
\n\nArguments:
\n\n\n- n_freq: Must be
> 2
. Number of lowest frequency bins distinct from zero. \n- amplitude: Upper boundary for the uniform random generator.
\n- pedestal: Additive constant pedestal to the spectrum.
\n- func: Callable. User-defined function to be added as baseline. Example:
func = lambda x: x*.01 + x**2*.0001
. \n- rng_seed:
int
, optional. Seed for the random generator. \n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_freq: int,\tamplitude: float,\tpedestal: float = 0,\tfunc: Optional[Callable] = None,\trng_seed=None):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.central_moments", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.central_moments", "kind": "function", "doc": "\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tboundaries=(-inf, inf),\tmoments=[1, 2, 3, 4],\tnormalize=False):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.scale_yaxis_linear", "kind": "function", "doc": "Scale y-axis values
\n\nThis function provides the same result as spe*const
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- factor optional. Defaults to 1.\nY-values scaling factor
\n
\n\nReturns: corrected spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\tfactor: float = 1):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.normalize", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.normalize", "kind": "function", "doc": "Normalize the spectrum.
\n\nArguments:
\n\n\n- strategy: If
unity
: normalize to sum(y)
. If min_unity
: subtract the minimum and normalize to 'unity'. If\nunity_density
: normalize to \u03a3(y_i*\u0394x_i)
. If unity_area
: same as unity_density
. If minmax
: scale\namplitudes in range [0, 1]
. If 'L1' or 'L2': L1 or L2 norm without subtracting the pedestal. \n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tstrategy: Literal['unity', 'min_unity', 'unity_density', 'unity_area', 'minmax', 'L1', 'L2'] = 'minmax'):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.abs_nm_to_shift_cm_1", "kind": "function", "doc": "Convert wavelength to Ramanshift in wavenumber
\n\nArguments:
\n\n\n- spe: internal use only
\n- laser_wave_length_nm: Laser wave length
\n
\n\nReturns: Corrected x-values
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tlaser_wave_length_nm: float):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.shift_cm_1_to_abs_nm", "kind": "function", "doc": "Convert Ramanshift in wavenumber to wavelength
\n\nArguments:
\n\n\n- spe: internal use only
\n- laser_wave_length_nm: Laser wave length
\n
\n\nReturns: Corrected x-values
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tlaser_wave_length_nm: float):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.abs_nm_to_shift_cm_1_filter", "kind": "function", "doc": "Convert wavelength to Ramanshift in wavenumber
\n\nArguments:
\n\n\n- spe: internal use only
\n- laser_wave_length_nm: Laser wave length
\n
\n\nReturns: Spectrum with corrected x-values
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tlaser_wave_length_nm: float):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.shift_cm_1_to_abs_nm_filter", "kind": "function", "doc": "Convert Ramanshift in wavenumber to wavelength
\n\nArguments:
\n\n\n- spe: internal use only
\n- laser_wave_length_nm: Laser wave length
\n
\n\nReturns: Spectrum with corrected x-values
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tlaser_wave_length_nm: float):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.calibrate_by_deltas_model", "kind": "function", "doc": "\n- Builds a composite model based on a set of user specified delta lines.
\n- Initial guess is calculated based on 10-th and 90-th percentiles of\nthe distributions.
\n
\n\nThe phasespace of the model is flat with big amount of narrow minima.\nIn order to find the best fit, the experimental data are successively\nconvolved with gaussians with different widths startign from wide to\nnarrow. The model for the calibration is 3-th order polynomial, which\npotentialy can be changed for higher order polynomial. In order to avoid\nsolving the inverse of the calibration function, the result is tabulated\nand interpolated linarly for each bin of the spectrum.\nThis alogrithm is useful for corse calibration.
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tdeltas: Dict[float, float],\tbounds: Optional[ramanchada2.spectrum.calibration.by_deltas.FitBounds] = None,\tconvolution_steps: Optional[List[float]] = [15, 1],\tscale2=True,\tscale3=False,\tinit_guess: Literal[None, 'cumulative'] = None,\tax=None,\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.calibrate_by_deltas_filter", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tdeltas: Dict[float, float],\tconvolution_steps,\tinit_guess=None,\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.xcal_fine", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*,\tref: Union[Dict[float, float], List[float]],\tshould_fit=False,\tpoly_order: typing.Annotated[int, Ge(ge=0)],\tfind_peaks_kw={}):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.xcal_fine_RBF", "kind": "function", "doc": "Wavelength calibration using Radial basis fuction interpolation
\n\nPlease be cautious! Interpolation might not be the most appropriate\napproach for this type of calibration.
\n\n**kwargs are passed to RBFInterpolator
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*,\tref: Union[Dict[float, float], List[float], numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]]],\tshould_fit=False,\tkernel: Literal['thin_plate_spline', 'cubic', 'quintic', 'multiquadric', 'inverse_multiquadric', 'inverse_quadratic', 'gaussian'] = 'thin_plate_spline',\tfind_peaks_kw={},\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.xcal_argmin2d_iter_lowpass", "kind": "function", "doc": "\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*,\tref: Dict[float, float],\tlow_pass_nfreqs: List[int] = [100, 500]):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.set_new_xaxis", "kind": "function", "doc": "Substitute x-axis values with new ones
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- xaxis: new x-axis values
\n
\n\nReturns: corrected spectrum
\n\nRaises:
\n\n\n- ValueError: If the provided array does not match the shape of the spectrum.
\n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\txaxis: numpy.ndarray[typing.Any, numpy.dtype[+_ScalarType_co]]):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.scale_xaxis_linear", "kind": "function", "doc": "Scale x-axis using a factor.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- factor: Defaults to 1.\nMultiply x-axis values with
factor
\n- preserve_integral: optional. Defaults to False.\nIf True, preserves the integral in sence\n$\\sum y_{orig;\\,i}*{\\Delta x_{orig}}_i = \\sum y_{new;\\,i}*{\\Delta x_{new}}_i = $
\n
\n\nReturns: Corrected spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tfactor: float = 1,\tpreserve_integral: bool = False):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.scale_xaxis_fun", "kind": "function", "doc": "Apply arbitrary calibration function to the x-axis values.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- fun: function to be applied
\n- args: Additional arguments to the provided functions
\n
\n\nReturns: Corrected spectrum
\n\nRaises:
\n\n\n- ValueError: If the new x-values are not strictly monotonically increasing.
\n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tfun: Callable[[Union[int, numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]]]], float],\targs=[]):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.from_cache_or_calc", "kind": "function", "doc": "Load spectrum from cache or calculate if needed.
\n\nThe cache is a nested structure of spectra. All processings applied to\na spectrum result to spectra of the initial one. If part of the requred\nprocessings are available, only the needed steps are calculated and added\nto the cache.
\n\nArguments:
\n\n\n- required_steps: List of required steps in the form\n[{'proc': str, 'args': List[Any], 'kwargs': Dict[str, Any]}, ...]
\n- cachefile: optional. Defaults to None.\nFilename of the cache. If None no cache is used
\n
\n", "signature": "(\trequired_steps: ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel,\tcachefile: Optional[str] = None):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.from_chada", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.from_chada", "kind": "function", "doc": "\n", "signature": "(filename: str, dataset: str = '/raw', h5module=None):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.from_delta_lines", "kind": "function", "doc": "Generate Spectrum
with delta lines.
\n\nArguments:
\n\n\n- deltas: Keys of the dictionary are the
x
positions of the deltas; values are the amplitudes of the corresponding\ndeltas. \n- xcal: Callable, optional.
x
axis calibration function. \n- nbins:
int
, optional. Number of bins in the spectrum. \n- xaxis:
Array-like
, optional. The xaxis of the new spectrum. If xaxis
is provided,\nxcal
should be None
and nbins
is ignored. \n
\n\nExample:
\n\nThis will produce spectrum with 1000 bins in the range [-1000, 2000)
:
\n\n\n
xcal = lambda x: x*3 -1000, nbins=1000\n
\n
\n", "signature": "(\tdeltas: Dict[float, float],\txcal: Optional[Callable[[float], float]] = None,\tnbins: typing.Annotated[int, Gt(gt=0)] = 2000,\txaxis: Optional[numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]]] = None,\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.from_local_file", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.from_local_file", "kind": "function", "doc": "Read experimental spectrum from a local file.
\n\nArguments:
\n\n\n- in_file_name: Path to a local file containing a spectrum.
\n- filetype: Specify the filetype. Filetype can be any of:
spc
, sp
, spa
, 0
, 1
, 2
, wdf
, ngs
, jdx
, dx
,\ntxt
, txtr
, csv
, prn
, rruf
, spe
(Princeton Instruments) or None
.\nNone
used to determine by extension of the file. \n- backend:
native
, rc1_parser
or None
. None
means both. \n
\n\nRaises:
\n\n\n- ValueError: When called with unsupported file formats.
\n
\n", "signature": "(\tin_file_name: str,\tfiletype: Optional[Literal['spc', 'sp', 'spa', '0', '1', '2', 'wdf', 'ngs', 'jdx', 'dx', 'txt', 'txtr', 'csv', 'prn', 'rruf', 'spe']] = None,\tbackend: Optional[Literal['native', 'rc1_parser']] = None):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.from_simulation", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.from_simulation", "kind": "function", "doc": "Generate spectrum from simulation file.
\n\nThe returned spectrum has only few x/y pairs -- one for each simulated line. Values along\nthe x-axis will not be uniform. To make it uniform, one needs to resample the spectrum.
\n\nArguments:
\n\n\n- in_file: Path to a local file, or file-like object.
\n- sim_type: If
vasp
: .dat
file from VASP simulation. If crystal_out
: .out
file from CRYSTAL simulation, not\npreferred. If crystal_dat
: .dat
file from CRYSTAL simulation. \n- use: One of the directions
I_tot
, I_perp
, I_par
, I_xx
, I_xy
,\nI_xz
, I_yy
, I_yz
, I_zz
, I_tot
, I_perp
, I_par
are\navailable for both CRYSTAL and VASP. I_xx
, I_xy
, I_xz
,\nI_yy
, I_yz
, I_zz
are available only for CRYSTAL. If a Dict is\npassed, the key should be directions and values should be weighting factor.\nFor example, use={'I_perp': .1, 'I_par': .9}
\n
\n", "signature": "(\tin_file: Union[str, io.TextIOBase],\tsim_type: Literal['vasp', 'crystal_out', 'crystal_dat', 'raw_dat'],\tuse: Union[Literal['I_tot', 'I_perp', 'I_par', 'I_xx', 'I_xy', 'I_xz', 'I_yy', 'I_yz', 'I_zz'], Dict[Literal['I_tot', 'I_perp', 'I_par', 'I_xx', 'I_xy', 'I_xz', 'I_yy', 'I_yz', 'I_zz'], Annotated[float, Gt(gt=0)]]] = 'I_tot',\tnbins: typing.Annotated[int, Gt(gt=0)] = 2000):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.from_spectral_component_collection", "kind": "function", "doc": "from_spectral_component_collection
\n\nArguments:
\n\n\n- spe_components: SpectralComponentCollection
\n- x:
int
or array-like, optional, default 2000
. x
axis of the spectrum. \n
\n", "signature": "(\tspe_components: ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection,\tx=2000):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.from_stream", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.from_stream", "kind": "function", "doc": "\n", "signature": "(\tin_stream: Union[io.TextIOBase, _io.BytesIO, _io.BufferedReader],\tfiletype: Optional[Literal['spc', 'sp', 'spa', '0', '1', '2', 'wdf', 'ngs', 'jdx', 'dx', 'txt', 'txtr', 'csv', 'prn', 'rruf', 'spe']],\tfilename: Optional[str] = None,\tbackend: Optional[Literal['native', 'rc1_parser']] = None):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.from_test_spe", "kind": "function", "doc": "Create new spectrum from test data.
\n\nArguments:
\n\n\n- index:
int
or None
, optional, default is None
. If int
: will be used as an index of filtered list. If\nNone
: a random spectrum will be taken. \n- **kwargs: The rest of the parameters will be used as filter.
\n
\n", "signature": "(index=None, **kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.from_theoretical_lines", "kind": "function", "doc": "Generate spectrum from lmfit
shapes.
\n\nArguments:
\n\n\n- shapes: The shapes to be used for spectrum generation.
\n- params: Shape parameters to be applied to be used with shapes.
\n- x: Array with
x
values, by default np.array(2000)
. \n
\n", "signature": "(\tshapes: List[Literal['gaussian', 'gaussian2d', 'lorentzian', 'voigt', 'pvoigt', 'moffat', 'pearson4', 'pearson7', 'breit_wigner', 'damped_oscillator', 'dho', 'logistic', 'lognormal', 'students_t', 'expgaussian', 'doniach', 'skewed_gaussian', 'skewed_voigt', 'thermal_distribution', 'step', 'rectangle', 'exponential', 'powerlaw', 'linear', 'parabolic', 'sine', 'expsine', 'split_lorentzian']],\tparams: List[Dict],\tx: Union[int, numpy.ndarray[Any, numpy.dtype[numpy.float64]]] = 2000):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.hdr_from_multi_exposure", "kind": "function", "doc": "Create an HDR spectrum from several spectra with different exposures.
\n\nThe resulting spectrum will have the details in low-intensity peaks\nfrom long-exposure-time spectrum. As long-exposure-time\nspectrum might be sturated, the information for high-intensity\npeaks will be taken from short-exposure-time spectrum.\nThis function will work on a very limited number of spectra,\nbecause we still do not have standardized metadata.
\n", "signature": "(spes_in: List[ramanchada2.spectrum.spectrum.Spectrum]):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.moving_average", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.moving_average", "kind": "function", "doc": "Moving average filter.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- window_size:
int
, optional, default is 10
. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\twindow_size: typing.Annotated[int, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.moving_average_convolve", "kind": "function", "doc": "Moving average filter.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- window_size:
int
, optional, default is 10
. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\twindow_size: typing.Annotated[int, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.add_gaussian_noise", "kind": "function", "doc": "Add gaussian noise to the spectrum.
\n\nRandom number i.i.d. $N(0, \\sigma)$ is added to every sample
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- sigma: Sigma of the gaussian noise.
\n- rng_seed:
int
or rng state, optional, seed for the random generator.\nIf a state is provided, it is updated in-place. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tsigma: typing.Annotated[float, Gt(gt=0)],\trng_seed=None):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.add_poisson_noise", "kind": "function", "doc": "Add poisson noise to the spectrum.
\n\nFor each particular sample the noise is proportional to $\\sqrt{scale*a_i}$.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- scale:
float
, optional, default is 1
. Scale the amplitude of the noise. \n- rng_seed:
int
or rng state, optional. Seed for the random generator.\nIf a state is provided, it is updated in-place. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tscale: float = 1,\trng_seed=None):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.convolve", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.convolve", "kind": "function", "doc": "Convole spectrum with arbitrary lineshape.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- lineshape: callable,
str
or np.ndarray
.\n If callable: should have a single positional argument x
, e.g.\nlambda x: np.exp((x/5)**2)
.\nIf predefined peak profile: can be gaussian
, lorentzian
, voigt
,\npvoigt
, moffat
or pearson4
.\nIf np.ndarray
: lineshape in samples. \n- **kwargs: Additional kwargs will be passed to lineshape function.
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tlineshape: Union[Callable[[Union[float, numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]]]], float], numpy.ndarray[Any, numpy.dtype[+_ScalarType_co]], Literal['gaussian', 'lorentzian', 'voigt', 'pvoigt', 'moffat', 'pearson4', 'pearson7']],\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.derivative_sharpening", "kind": "function", "doc": "Derivative-based sharpening.
\n\nSharpen the spectrum subtracting second derivative and add fourth derivative.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- filter_fraction
float
in (0; 1]: Default is 0.6\nDepth of filtration \n- signal_width: The width of features to be enhanced in sample count
\n- der2_factor: Second derivative scaling factor
\n- der4_factor: Fourth derivative scaling factor
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tfilter_fraction: typing.Annotated[float, None, Interval(gt=0, ge=None, lt=None, le=1), None, None] = 0.6,\tsig_width: typing.Annotated[float, None, Interval(gt=None, ge=0, lt=None, le=None), None, None] = 0.25,\tder2_factor: float = 1,\tder4_factor: float = 0.1):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.hht_sharpening", "kind": "function", "doc": "Hilbert-Huang based sharpening.
\n\nIn order to reduce the overshooting, moving minimum is subtracted from the result
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- movmin: optional. Default is 100\nWindow size for moving minimum
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tmovmin=100):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.hht_sharpening_chain", "kind": "function", "doc": "Hilbert-Huang based chain sharpening.
\n\nSequence of Hilbert-Huang sharpening procedures are performed.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- movmin: List[int], optional. Default is [150, 50]\nThe numer of values in the list defines how many iterations\nof HHT_sharpening will be performed and the values define\nthe moving minimum window sizes for the corresponding operations.
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tmovmin: List[Annotated[int, Gt(gt=0)]] = [150, 50]):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.spike_indices", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.spike_indices", "kind": "function", "doc": "Find spikes in spectrum
\n\nSingle-bin spikes are located using left and right successive\ndifferences. The threshold is based on the standart deviation\nof the metric which makes this algorithm less optimal.
\n\nArguments:
\n\n\n- spe: internal use only
\n- n_sigma: Threshold value should be
n_sigma
times the standart\ndeviation of the metric. \n
\n\nReturns: List of spike indices
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_sigma: typing.Annotated[float, Gt(gt=0)]) -> numpy.ndarray[typing.Any, numpy.dtype[+_ScalarType_co]]:", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.drop_spikes", "kind": "function", "doc": "Removes single-bin spikes.
\n\nRemove x, y pairs recognised as spikes using left and right\nsuccessive differences and standard-deviation-based threshold.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- n_sigma: optional, default is
10
.\nThreshold is n_sigma
times the standard deviation. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_sigma: typing.Annotated[float, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.recover_spikes", "kind": "function", "doc": "Recover single-bin spikes.
\n\nRecover x, y pairs recognised as spikes using left and right\nsuccessive differences and standard-deviation-based threshold\nand linear interpolation.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- n_sigma: optional, default is
10
.\nThreshold is n_sigma
times the standard deviation. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_sigma: typing.Annotated[float, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.get_spikes", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.get_spikes", "kind": "function", "doc": "Get single-bin spikes only.
\n\nGet x, y pairs recognised as spikes using left and right\nsuccessive differences and standard-deviation-based threshold\nand linear interpolation.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- n_sigma: optional, default is
10
.\nThreshold is n_sigma
times the standard deviation. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_sigma: typing.Annotated[float, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.moving_median", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.moving_median", "kind": "function", "doc": "Moving median filter.
\n\nThe resultant spectrum is moving minimum of the input.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- window_size:
int
, optional, default is 10
. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\twindow_size: typing.Annotated[int, Gt(gt=0)] = 10):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.subtract_moving_median", "kind": "function", "doc": "Subtract moving median filter.
\n\nThe resultant spectrum is moving minimum of the input subtracted from the input.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- window_size:
int
, optional, default is 10
. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\twindow_size: int):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.trim_axes", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.trim_axes", "kind": "function", "doc": "Trim axes of the spectrum.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- method: 'x-axis' or 'bins'\nIf 'x-axis' boundaries will be interpreted as x-axis values.\nIf 'bins' boundaries will be interpreted as indices.
\n- boundaries: lower and upper boundary for the trimming.
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tmethod: Literal['x-axis', 'bins'],\tboundaries: Tuple[float, float]):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.add_gaussian_noise_drift", "kind": "function", "doc": "Add cumulative gaussian noise to the spectrum.
\n\nExponential-moving-average-like gaussian noise is added\nto each sample. The goal is to mimic the low-frequency noise\n(or random substructures in spectra).\nThe additive noise is\n$$a_i = coef*\\sum_{j=0}^{i-1}g_j + g_i,$$
\n\nwhere\n$$g_i = \\mathcal{N}(0, 1+\\frac{coef}{\\sqrt 2}).$$
\n\nThis way drifting is possible while keeping the\n$$\\sigma(\\Delta(a)) \\approx 1.$$
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- sigma: Sigma of the gaussian noise.
\n- coef:
float
in [0, 1]
, drifting coefficient. If coef == 0
,\nthe result is identical to add_gaussian_noise()
. \n- rng_seed:
int
or rng state, optional. Seed for the random generator.\nIf a state is provided, it is updated in-place. \n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tsigma: typing.Annotated[float, Gt(gt=0)],\tcoef: typing.Annotated[float, None, Interval(gt=None, ge=0, lt=None, le=1), None, None],\trng_seed=None):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.resample_NUDFT", "kind": "function", "doc": "Resample the spectrum using Non-uniform discrete fourier transform.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with NUDFT and inverse FFT.
\n\nArguments:
\n\n\n- spe: internal use only
\n- x_range: optional. Defaults to (0, 4000).\nThe x_range of the new spectrum.
\n- xnew_bins: optional. Defaults to 100.\nNumber of bins of the new spectrum
\n- window: optional, Defaults to None.\nThe window to be used for lowpass filter. If None 'blackmanharris' is used.\nIf no low-pass filter is required, one can use
window=lambda x: [1]*len(x)
. \n- cumulative: optional. Defaults to False.\nIf True, the resultant spectrum will be cumulative and normalized\n(in analogy with CDF).
\n
\n\nReturns:
\n\n\n (x_values, y_values)
\n
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tx_range: Tuple[float, float] = (0, 4000),\txnew_bins: typing.Annotated[int, Gt(gt=0)] = 100,\twindow: Union[Callable, Tuple[Any, ...], Literal['barthann', 'bartlett', 'blackman', 'blackmanharris', 'bohman', 'boxcar', 'chebwin', 'cosine', 'dpss', 'exponential', 'flattop', 'gaussian', 'general_cosine', 'general_gaussian', 'general_hamming', 'hamming', 'hann', 'kaiser', 'nuttall', 'parzen', 'taylor', 'triang', 'tukey'], NoneType] = None,\tcumulative: bool = False):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.resample_NUDFT_filter", "kind": "function", "doc": "Resample the spectrum using Non-uniform discrete fourier transform.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with NUDFT and inverse FFT.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- x_range: optional. Defaults to (0, 4000).\nThe x_range of the new spectrum.
\n- xnew_bins: optional. Defaults to 100.\nNumber of bins of the new spectrum
\n- window: optional, Defaults to None.\nThe window to be used for lowpass filter. If None 'blackmanharris' is used.\nIf no low-pass filter is required, one can use
window=lambda x: [1]*len(x)
. \n- cumulative: optional. Defaults to False.\nIf True, the resultant spectrum will be cumulative and normalized\n(in analogy with CDF).
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tx_range: Tuple[float, float] = (0, 4000),\txnew_bins: typing.Annotated[int, Gt(gt=0)] = 100,\twindow=None,\tcumulative: bool = False):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.resample_spline", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.resample_spline", "kind": "function", "doc": "Resample the spectrum using spline interpolation.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with spline interpolation.
\n\nArguments:
\n\n\n- spe: internal use only
\n- x_range: optional. Defaults to (0, 4000).\nThe x_range of the new spectrum.
\n- xnew_bins: optional. Defaults to 100.\nNumber of bins of the new spectrum
\n- spline: optional, Defaults to 'pchip'.\nName of the spline funcion to be used.
\n- cumulative: optional. Defaults to False.\nIf True, the resultant spectrum will be cumulative and normalized\n(in analogy with CDF).
\n
\n\nReturns:
\n\n\n (x_values, y_values)
\n
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tx_range: Tuple[float, float] = (0, 4000),\txnew_bins: typing.Annotated[int, Gt(gt=0)] = 100,\tspline: Literal['pchip', 'akima', 'makima', 'cubic_spline'] = 'pchip',\tinterp_kw_args: Optional[Dict] = None,\tcumulative: bool = False):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.resample_spline_filter", "kind": "function", "doc": "Resample the spectrum using spline interpolation.
\n\nThe x-axis of the result will be uniform. The corresponding y-values\nwill be calculated with spline interpolation.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- x_range: optional. Defaults to (0, 4000).\nThe x_range of the new spectrum.
\n- xnew_bins: optional. Defaults to 100.\nNumber of bins of the new spectrum
\n- spline: optional, Defaults to 'pchip'.\nName of the spline funcion to be used.
\n- cumulative: optional. Defaults to False.\nIf True, the resultant spectrum will be cumulative and normalized\n(in analogy with CDF).
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tx_range: Tuple[float, float] = (0, 4000),\txnew_bins: typing.Annotated[int, Gt(gt=0)] = 100,\tspline: Literal['pchip', 'akima', 'makima', 'cubic_spline'] = 'pchip',\tinterp_kw_args: Optional[Dict] = None,\tcumulative: bool = False):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.pad_zeros", "kind": "function", "doc": "Extend x-axis by 100% in both directions.
\n\nThe x-axis of resultant spectrum will be:\n$[x_{lower}-(x_{upper}-x_{lower})..(x_{upper}+(x_{upper}-x_{lower}))]$.\nThe length of the new spectrum is 3 times the original. The added values\nare with an uniform step. In the middle is the original spectrum with\noriginal x and y values. The coresponding y vallues for the newly added\nx-values are always zeros.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.dropna", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.dropna", "kind": "function", "doc": "Remove non finite numbers on both axes
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.smoothing_RC1", "kind": "function", "doc": "Smooth the spectrum.
\n\nThe spectrum will be smoothed using the specified filter.\nThis method is inherited from ramanchada1 for compatibility reasons.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- method: method to be used
\n- **kwargs: keyword arguments to be passed to the selected method
\n
\n\nReturns: modified Spectrum
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*args,\tmethod: Literal['savgol', 'sg', 'wiener', 'median', 'gauss', 'gaussian', 'lowess', 'boxcar'],\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.bayesian_gaussian_mixture", "kind": "function", "doc": "Decompose the spectrum to Bayesian Gaussian Mixture
\n\nArguments:
\n\n\n- spe: internal use only
\n- n_samples: optional. Defaults to 5000.\nResampled dataset size
\n- n_components: optional. Defaults to 50.\nNumber of expected gaussian components
\n- max_iter: optional. Defaults to 100.\nMaximal number of iterations.
\n- moving_minimum_window: optional. Defaults to None.\nIf None no moving minimum is subtracted, otherwise as specified.
\n- random_state: optional. Defaults to None.\nRandom generator seed to be used.
\n- trim_range: optional. Defaults to None:\nIf None ignore trimming, otherwise trim range is in x-axis values.
\n
\n\nReturns:
\n\n\n BayesianGaussianMixture: Fitted Bayesian Gaussian Mixture
\n
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tn_samples: typing.Annotated[int, Gt(gt=0)] = 5000,\tn_components: typing.Annotated[int, Gt(gt=0)] = 50,\tmax_iter: typing.Annotated[int, Gt(gt=0)] = 100,\tmoving_minimum_window: Optional[Annotated[int, Gt(gt=0)]] = None,\trandom_state=None,\ttrim_range: Optional[Tuple[float, float]] = None) -> sklearn.mixture._bayesian_mixture.BayesianGaussianMixture:", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.fit_peak_positions", "kind": "function", "doc": "Calculate peak positions and amplitudes.
\n\nSequence of multiple processings:
\n\n\nsubtract_moving_minimum
\nfind_peak_multipeak
\n- filter peaks with x-location better than threshold
\n
\n\nArguments:
\n\n\n- spe: internal use only
\n- mov_min: optional. Defaults to 40\nsubtract moving_minimum with the specified window.
\n- center_err_threshold: optional. Defaults to 0.5.\nthreshold for centroid standard deviation. Only peaks\nwith better uncertainty will be returned.
\n- find_peaks_kw: optional\nkeyword arguments to be used with find_peak_multipeak
\n- fit_peaks_kw: optional\nkeyword arguments to be used with fit_peaks_multipeak
\n
\n\nReturns:
\n\n\n Dict[float, float]: {positions: amplitudes}
\n
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*,\tmov_min=40,\tcenter_err_threshold=0.5,\tfind_peaks_kw={},\tfit_peaks_kw={}) -> Dict[float, float]:", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.find_peak_multipeak", "kind": "function", "doc": "Find groups of peaks in spectrum.
\n\nArguments:
\n\n\n- spe: internal use only
\n- prominence: Optional. Defaults to None\nIf None the prominence value will be
spe.y_nose
. Reasonable value for\npromience is const * spe.y_noise_MAD
. \n- wlen: optional. Defaults to None.\nwlen value used in
scipy.signal.find_peaks
. If wlen is None, 200 will be used. \n- width: optional. Defaults to None.\nwidth value used in
scipy.signal.find_peaks
. If width is None, 2 will be used. \n- hht_chain: optional. Defaults to None.\nList of hht_chain window sizes. If None, no hht sharpening is performed.
\n- bgm_kwargs: kwargs for bayesian_gaussian_mixture
\n- sharpening 'hht' or None. Defaults to None.\nIf 'hht' hht sharpening will be performed before finding peaks.
\n- strategy: optional. Defauts to 'topo'.\nPeakfinding method
\n
\n\nReturns:
\n\n\n ListPeakCandidateMultiModel: Located peak groups
\n
\n", "signature": "(\tspe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\tprominence: Optional[Annotated[float, Ge(ge=0)]] = None,\twlen: Optional[Annotated[int, Ge(ge=0)]] = None,\twidth: Union[int, Tuple[int, int], NoneType] = None,\thht_chain: Optional[List[Annotated[int, Gt(gt=0)]]] = None,\tbgm_kwargs={},\tsharpening: Optional[Literal['hht']] = None,\tstrategy: Literal['topo', 'bayesian_gaussian_mixture', 'bgm', 'cwt'] = 'topo') -> ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel:", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.find_peak_multipeak_filter", "kind": "function", "doc": "Same as find_peak_multipeak
but the result is stored as metadata in the returned spectrum.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- args, *kwargs: same as
find_peak_multipeak
\n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*args,\t**kwargs):", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.fit_peak_multimodel", "kind": "function", "doc": "\n", "signature": "(\tspe,\t/,\t*,\tprofile: Union[Literal['Gaussian', 'Lorentzian', 'Moffat', 'Voigt', 'PseudoVoigt', 'Pearson4', 'Pearson7'], List[Literal['Gaussian', 'Lorentzian', 'Moffat', 'Voigt', 'PseudoVoigt', 'Pearson4', 'Pearson7']]],\tcandidates: ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel,\tno_fit=False,\tshould_break=[False],\tkwargs_fit={},\tvary_baseline: bool = False,\tbound_centers_to_group: bool = False) -> ramanchada2.misc.types.fit_peaks_result.FitPeaksResult:", "funcdef": "def"}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"fullname": "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter", "modulename": "ramanchada2.spectrum.spectrum", "qualname": "Spectrum.fit_peaks_filter", "kind": "function", "doc": "Same as fit_peak_multipeak
but the result is stored as metadata in the returned spectrum.
\n\nArguments:
\n\n\n- old_spe: internal use only
\n- new_spe: internal use only
\n- should_break: same as in fit_peaks_multipeak
\n- args, *kwargs: same as
fit_peaks_multipeak
\n
\n", "signature": "(\told_spe: ramanchada2.spectrum.spectrum.Spectrum,\tnew_spe: ramanchada2.spectrum.spectrum.Spectrum,\t/,\t*args,\tshould_break=[False],\tkwargs_fit={},\t**kwargs):", "funcdef": "def"}, "ramanchada2.theoretical_lines": {"fullname": "ramanchada2.theoretical_lines", "modulename": "ramanchada2.theoretical_lines", "kind": "module", "doc": "\n"}, "ramanchada2.theoretical_lines.model_from_lines": {"fullname": "ramanchada2.theoretical_lines.model_from_lines", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "kind": "module", "doc": "\n"}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"fullname": "ramanchada2.theoretical_lines.model_from_lines.model_from_lines", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "qualname": "model_from_lines", "kind": "function", "doc": "\n", "signature": "(\tnames: List[str],\tpositions: List[float],\tintensities: Dict[str, List[float]],\tmodel: Literal['gaussian', 'voigt'] = 'gaussian') -> Tuple[lmfit.model.Model, lmfit.parameter.Parameters]:", "funcdef": "def"}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"fullname": "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "qualname": "PydPeakModel", "kind": "class", "doc": "Usage docs: https://docs.pydantic.dev/2.9/concepts/models/
\n\nA base class for creating Pydantic models.
\n\nAttributes:
\n\n\n- __class_vars__: The names of the class variables defined on the model.
\n- __private_attributes__: Metadata about the private attributes of the model.
\n- __signature__: The synthesized
__init__
[Signature
][inspect.Signature] of the model. \n- __pydantic_complete__: Whether model building is completed, or if there are still undefined fields.
\n- __pydantic_core_schema__: The core schema of the model.
\n- __pydantic_custom_init__: Whether the model has a custom
__init__
function. \n- __pydantic_decorators__: Metadata containing the decorators defined on the model.\nThis replaces
Model.__validators__
and Model.__root_validators__
from Pydantic V1. \n- __pydantic_generic_metadata__: Metadata for generic models; contains data used for a similar purpose to\n__args__, __origin__, __parameters__ in typing-module generics. May eventually be replaced by these.
\n- __pydantic_parent_namespace__: Parent namespace of the model, used for automatic rebuilding of models.
\n- __pydantic_post_init__: The name of the post-init method for the model, if defined.
\n- __pydantic_root_model__: Whether the model is a [
RootModel
][pydantic.root_model.RootModel]. \n- __pydantic_serializer__: The
pydantic-core
SchemaSerializer
used to dump instances of the model. \n- __pydantic_validator__: The
pydantic-core
SchemaValidator
used to validate instances of the model. \n- __pydantic_extra__: A dictionary containing extra values, if [
extra
][pydantic.config.ConfigDict.extra]\nis set to 'allow'
. \n- __pydantic_fields_set__: The names of fields explicitly set during instantiation.
\n- __pydantic_private__: Values of private attributes set on the model instance.
\n
\n", "bases": "pydantic.main.BaseModel"}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"fullname": "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "qualname": "PydPeakModel.model", "kind": "variable", "doc": "\n", "annotation": ": Literal['gaussian', 'voigt']"}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"fullname": "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "qualname": "PydPeakModel.position", "kind": "variable", "doc": "\n", "annotation": ": float"}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"fullname": "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "qualname": "PydPeakModel.inensity", "kind": "variable", "doc": "\n", "annotation": ": float"}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"fullname": "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "qualname": "PydPeakModel.sigma", "kind": "variable", "doc": "\n", "annotation": ": float"}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"fullname": "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "qualname": "PydPeakModel.name", "kind": "variable", "doc": "\n", "annotation": ": str"}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"fullname": "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "qualname": "PydPeakModel.model_config", "kind": "variable", "doc": "Configuration for the model, should be a dictionary conforming to [ConfigDict
][pydantic.config.ConfigDict].
\n", "annotation": ": ClassVar[pydantic.config.ConfigDict]", "default_value": "{}"}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"fullname": "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "qualname": "PydPeakModel.model_fields", "kind": "variable", "doc": "Metadata about the fields defined on the model,\nmapping of field names to [FieldInfo
][pydantic.fields.FieldInfo] objects.
\n\nThis replaces Model.__fields__
from Pydantic V1.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.FieldInfo]]", "default_value": "{'model': FieldInfo(annotation=Literal['gaussian', 'voigt'], required=False, default='voigt'), 'position': FieldInfo(annotation=float, required=True), 'inensity': FieldInfo(annotation=float, required=False, default=1, metadata=[Gt(gt=0)]), 'sigma': FieldInfo(annotation=float, required=False, default=1, metadata=[Gt(gt=0)]), 'name': FieldInfo(annotation=str, required=False, default='')}"}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"fullname": "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "qualname": "PydPeakModel.model_computed_fields", "kind": "variable", "doc": "A dictionary of computed field names and their corresponding ComputedFieldInfo
objects.
\n", "annotation": ": ClassVar[Dict[str, pydantic.fields.ComputedFieldInfo]]", "default_value": "{}"}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"fullname": "ramanchada2.theoretical_lines.model_from_lines.model_from_list", "modulename": "ramanchada2.theoretical_lines.model_from_lines", "qualname": "model_from_list", "kind": "function", "doc": "\n", "signature": "(\tpeaks_list: List[ramanchada2.theoretical_lines.model_from_lines.PydPeakModel]) -> Tuple[lmfit.model.Model, lmfit.parameter.Parameters]:", "funcdef": "def"}}, "docInfo": {"ramanchada2": {"qualname": 0, "fullname": 1, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 5124}, "ramanchada2.auxiliary": {"qualname": 0, "fullname": 2, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra.datasets2": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra.datasets2.data": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 9356, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra.datasets2.df": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 60, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra.datasets2.loc": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 8, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 13, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra.datasets2.get_filters": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 13, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 13, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra.simulated": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra.simulated.loc": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 8, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 50, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io": {"qualname": 0, "fullname": 2, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.HSDS": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.HSDS.logger": {"qualname": 1, "fullname": 4, "annotation": 0, "default_value": 7, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.HSDS.write_nexus": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 142, "bases": 0, "doc": 3}, "ramanchada2.io.HSDS.DatasetExistsError": {"qualname": 1, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 2, "doc": 11}, "ramanchada2.io.HSDS.sanitize_key": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 19, "bases": 0, "doc": 3}, "ramanchada2.io.HSDS.write_cha": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 142, "bases": 0, "doc": 3}, "ramanchada2.io.HSDS.read_cha": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 116, "bases": 0, "doc": 3}, "ramanchada2.io.HSDS.filter_dataset": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 102, "bases": 0, "doc": 3}, "ramanchada2.io.HSDS.visit_domain": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 51, "bases": 0, "doc": 3}, "ramanchada2.io.experimental": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.bw_format": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.bw_format.bw_format": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 52, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.neegala_format": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 52, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.binary_readers": {"qualname": 0, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"qualname": 1, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 26, "bases": 0, "doc": 60}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"qualname": 2, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"qualname": 3, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 26, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"qualname": 2, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"qualname": 3, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.io": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 2, "doc": 11}, "ramanchada2.io.experimental.rc1_parser.io.parse": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 23, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.third_party_readers": {"qualname": 0, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"qualname": 1, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"qualname": 1, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"qualname": 1, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 22, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers": {"qualname": 0, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"qualname": 1, "fullname": 9, "annotation": 0, "default_value": 14, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"qualname": 2, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 21, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"qualname": 1, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 43, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"qualname": 1, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 12, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"qualname": 1, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"qualname": 1, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"qualname": 1, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 12, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.read_csv": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.read_csv.read_csv": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 95, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.read_spe": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.read_spe.read_spe": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 6}, "ramanchada2.io.experimental.read_txt": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.read_txt.read_txt": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 95, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rruf_format": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 100, "bases": 0, "doc": 3}, "ramanchada2.io.output": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.output.write_csv": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.output.write_csv.write_csv": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 38, "bases": 0, "doc": 3}, "ramanchada2.io.simulated": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.crystal": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.crystal.discrete_lines_dat": {"qualname": 0, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"qualname": 4, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 40, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.crystal.discrete_lines_out": {"qualname": 0, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"qualname": 4, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 40, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.lines_from_raw_dat": {"qualname": 0, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"qualname": 4, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 40, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.read_simulated_lines": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 251, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.vasp": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat": {"qualname": 0, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"qualname": 4, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 40, "bases": 0, "doc": 15}, "ramanchada2.misc": {"qualname": 0, "fullname": 2, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.base_class": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.base_class.BaseClass": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.base_class.BaseClass.origin": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.base_class.BaseClass.origin_list_str": {"qualname": 4, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.PST_RS_dict": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 33, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 1176, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.polystyrene_rs": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 33, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_rs_dict": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 1826, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_wl_dict": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 1826, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_rs_spe": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 1899, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_wl_spe": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 1903, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 216, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 236, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 148, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 136, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 334, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 334, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 532, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 487, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_wl_D3_3": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 152, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 222, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.constants.NEON_WL": {"qualname": 2, "fullname": 5, "annotation": 2, "default_value": 752, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.exceptions": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.exceptions.ApplicationException": {"qualname": 1, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 2, "doc": 11}, "ramanchada2.misc.exceptions.InputParserError": {"qualname": 1, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 1, "doc": 11}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"qualname": 1, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 1, "doc": 11}, "ramanchada2.misc.plottable": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.plottable.Plottable": {"qualname": 1, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 2, "doc": 16}, "ramanchada2.misc.plottable.Plottable.plot": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 60, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.dynamically_added": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"qualname": 3, "fullname": 9, "annotation": 2, "default_value": 199, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"qualname": 3, "fullname": 9, "annotation": 2, "default_value": 52, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.spectrum_constructor": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"qualname": 5, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"qualname": 5, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.spectrum_filter": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 12, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.spectrum_method": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 6, "doc": 14}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 22, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 28, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"qualname": 4, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 43, "bases": 0, "doc": 3}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"qualname": 4, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 7, "doc": 390}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"qualname": 2, "fullname": 7, "annotation": 7, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakModel.position": {"qualname": 2, "fullname": 7, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"qualname": 2, "fullname": 7, "annotation": 7, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"qualname": 2, "fullname": 7, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"qualname": 2, "fullname": 7, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"qualname": 2, "fullname": 7, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 8}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"qualname": 2, "fullname": 7, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 8}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 8, "signature": 0, "bases": 0, "doc": 18}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"qualname": 3, "fullname": 8, "annotation": 5, "default_value": 50, "signature": 0, "bases": 0, "doc": 35}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"qualname": 4, "fullname": 9, "annotation": 5, "default_value": 1, "signature": 0, "bases": 0, "doc": 16}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 11, "doc": 390}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"qualname": 2, "fullname": 7, "annotation": 7, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"qualname": 3, "fullname": 8, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"qualname": 3, "fullname": 8, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"qualname": 2, "fullname": 7, "annotation": 3, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"qualname": 5, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"qualname": 5, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 8, "signature": 0, "bases": 0, "doc": 18}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"qualname": 3, "fullname": 8, "annotation": 5, "default_value": 45, "signature": 0, "bases": 0, "doc": 35}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"qualname": 4, "fullname": 9, "annotation": 5, "default_value": 1, "signature": 0, "bases": 0, "doc": 16}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 5, "doc": 92}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"qualname": 2, "fullname": 7, "annotation": 7, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"qualname": 5, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"qualname": 5, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.positive_not_multiple": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 6, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.pydantic_base_model": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 5, "doc": 390}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 8, "signature": 0, "bases": 0, "doc": 18}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"qualname": 3, "fullname": 9, "annotation": 5, "default_value": 1, "signature": 0, "bases": 0, "doc": 35}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"qualname": 4, "fullname": 10, "annotation": 5, "default_value": 1, "signature": 0, "bases": 0, "doc": 16}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 5, "doc": 92}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 3, "doc": 390}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"qualname": 2, "fullname": 8, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"qualname": 2, "fullname": 8, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"qualname": 2, "fullname": 8, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 21, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"qualname": 3, "fullname": 9, "annotation": 4, "default_value": 1, "signature": 0, "bases": 0, "doc": 18}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"qualname": 3, "fullname": 9, "annotation": 5, "default_value": 33, "signature": 0, "bases": 0, "doc": 35}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"qualname": 4, "fullname": 10, "annotation": 5, "default_value": 1, "signature": 0, "bases": 0, "doc": 16}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 5, "doc": 92}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"qualname": 2, "fullname": 8, "annotation": 8, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 36, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 56, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 25, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.metadata": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 37, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 5, "doc": 92}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"qualname": 2, "fullname": 7, "annotation": 29, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 5, "doc": 92}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"qualname": 2, "fullname": 7, "annotation": 8, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 20, "bases": 0, "doc": 13}, "ramanchada2.misc.utils": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.argmin2d": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.argmin2d.argmin2d": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 35, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"qualname": 4, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 24, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 24, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.argmin2d.align": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 182, "bases": 0, "doc": 40}, "ramanchada2.misc.utils.argmin2d.align_shift": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 92, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.matchsets": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 80, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 78, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.matchsets.cost_function": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 78, "bases": 0, "doc": 56}, "ramanchada2.misc.utils.matchsets.normalize_tuples": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 81, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.matchsets.match_peaks": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 92, "bases": 0, "doc": 293}, "ramanchada2.misc.utils.ramanshift_to_wavelength": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"qualname": 7, "fullname": 13, "annotation": 0, "default_value": 0, "signature": 19, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"qualname": 7, "fullname": 13, "annotation": 0, "default_value": 0, "signature": 19, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"qualname": 6, "fullname": 12, "annotation": 0, "default_value": 0, "signature": 19, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"qualname": 6, "fullname": 12, "annotation": 0, "default_value": 0, "signature": 19, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 21, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.svd": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.misc.utils.svd.svd_solve": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 5}, "ramanchada2.misc.utils.svd.svd_inverse": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.protocols": {"qualname": 0, "fullname": 2, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg": {"qualname": 0, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"qualname": 2, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 69, "bases": 0, "doc": 3}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"qualname": 2, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 94, "bases": 0, "doc": 109}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"qualname": 3, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 123, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.logger": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 11, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.ProcessingModel": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 4, "doc": 16}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 42, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"qualname": 2, "fullname": 7, "annotation": 12, "default_value": 5, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 37, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 59, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 68, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 55, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 60, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_model": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 10, "doc": 16}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 15, "bases": 0, "doc": 327}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"qualname": 2, "fullname": 7, "annotation": 12, "default_value": 5, "signature": 0, "bases": 0, "doc": 12}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 17, "bases": 0, "doc": 12}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 7}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 10}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 10}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 344, "bases": 0, "doc": 12}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 253, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 160, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 56, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 60, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 262, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.logger": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 10, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 6, "doc": 16}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 282, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"qualname": 4, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 96, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 55, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 34, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 30, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 6, "doc": 16}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 167, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 55, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"qualname": 7, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 37, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 95, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 4, "doc": 1560}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 18, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 17, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 4, "doc": 547}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 14, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 17, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 13}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 10}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 11}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 4, "doc": 2508}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 18, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 17, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 7, "doc": 295}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"qualname": 2, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"qualname": 2, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"qualname": 2, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"qualname": 2, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"qualname": 2, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"qualname": 2, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"qualname": 3, "fullname": 7, "annotation": 3, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"qualname": 3, "fullname": 7, "annotation": 3, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 17, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 31, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"qualname": 3, "fullname": 7, "annotation": 4, "default_value": 1, "signature": 0, "bases": 0, "doc": 18}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"qualname": 3, "fullname": 7, "annotation": 5, "default_value": 82, "signature": 0, "bases": 0, "doc": 35}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"qualname": 4, "fullname": 8, "annotation": 5, "default_value": 1, "signature": 0, "bases": 0, "doc": 16}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 252}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 17, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"qualname": 4, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 21, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 36, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 31, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 6, "doc": 364}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 50, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 55, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 25, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 25, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 25, "bases": 0, "doc": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 67, "bases": 0, "doc": 3}, "ramanchada2.protocols.metadata_helper": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.metadata_helper.MetadataExtractor": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 26, "bases": 0, "doc": 3}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 1, "doc": 3}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 9, "bases": 0, "doc": 3}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 26, "bases": 0, "doc": 3}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 1, "doc": 3}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 21, "bases": 0, "doc": 3}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 1, "doc": 3}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 26, "bases": 0, "doc": 3}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 1, "doc": 3}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 26, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"qualname": 1, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 3, "doc": 390}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"qualname": 3, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"qualname": 2, "fullname": 5, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"qualname": 2, "fullname": 5, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"qualname": 2, "fullname": 5, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"qualname": 3, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"qualname": 3, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"qualname": 4, "fullname": 7, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"qualname": 4, "fullname": 7, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"qualname": 3, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"qualname": 2, "fullname": 5, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"qualname": 3, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"qualname": 2, "fullname": 5, "annotation": 5, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 1, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"qualname": 3, "fullname": 6, "annotation": 4, "default_value": 8, "signature": 0, "bases": 0, "doc": 18}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"qualname": 3, "fullname": 6, "annotation": 5, "default_value": 152, "signature": 0, "bases": 0, "doc": 35}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"qualname": 4, "fullname": 7, "annotation": 5, "default_value": 1, "signature": 0, "bases": 0, "doc": 16}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"qualname": 1, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 4, "doc": 1882}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 59, "bases": 0, "doc": 59}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 59, "bases": 0, "doc": 62}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 72, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 52, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 128, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 46, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 46, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 61, "bases": 0, "doc": 3}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 49, "bases": 0, "doc": 1869}, "ramanchada2.protocols.twinning": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent": {"qualname": 1, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 4, "doc": 376}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 167, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.twinned": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.reference": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.boundaries": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"qualname": 3, "fullname": 6, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 39, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 90, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 76, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 69, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 60, "bases": 0, "doc": 3}, "ramanchada2.spectral_components": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.baseline": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.baseline.analytical": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.baseline.baseline_base": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 6, "doc": 16}, "ramanchada2.spectral_components.baseline.numerical": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 7, "doc": 16}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 14, "bases": 0, "doc": 25}, "ramanchada2.spectral_components.peak_profile": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.delta": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 6, "doc": 16}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"qualname": 4, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.gauss": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 6, "doc": 16}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"qualname": 4, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.voigt": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 6, "doc": 16}, "ramanchada2.spectral_components.spectral_component": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 9, "doc": 16}, "ramanchada2.spectral_components.spectral_component_collection": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 9, "doc": 16}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 16, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"qualname": 2, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.spectral_peak": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 8, "doc": 16}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.spectrum": {"qualname": 0, "fullname": 2, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.arithmetics": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.arithmetics.add": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.arithmetics.mul": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.arithmetics.sub": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.arithmetics.truediv": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.baseline": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.baseline.add_baseline": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 151, "bases": 0, "doc": 3}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 143, "bases": 0, "doc": 165}, "ramanchada2.spectrum.baseline.baseline_rc1": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 151, "bases": 0, "doc": 3}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 56, "bases": 0, "doc": 3}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 106, "bases": 0, "doc": 3}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 71, "bases": 0, "doc": 3}, "ramanchada2.spectrum.baseline.moving_minimum": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 72, "bases": 0, "doc": 17}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 72, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calc": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calc.central_moments": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 108, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 46, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 42, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 3, "doc": 390}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"qualname": 2, "fullname": 7, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"qualname": 2, "fullname": 7, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"qualname": 3, "fullname": 8, "annotation": 4, "default_value": 1, "signature": 0, "bases": 0, "doc": 18}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"qualname": 3, "fullname": 8, "annotation": 5, "default_value": 24, "signature": 0, "bases": 0, "doc": 35}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"qualname": 4, "fullname": 9, "annotation": 5, "default_value": 1, "signature": 0, "bases": 0, "doc": 16}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 3, "doc": 390}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"qualname": 2, "fullname": 7, "annotation": 7, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"qualname": 2, "fullname": 7, "annotation": 7, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"qualname": 2, "fullname": 7, "annotation": 7, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"qualname": 2, "fullname": 7, "annotation": 7, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"qualname": 3, "fullname": 8, "annotation": 4, "default_value": 1, "signature": 0, "bases": 0, "doc": 18}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"qualname": 3, "fullname": 8, "annotation": 5, "default_value": 62, "signature": 0, "bases": 0, "doc": 35}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"qualname": 4, "fullname": 9, "annotation": 5, "default_value": 1, "signature": 0, "bases": 0, "doc": 16}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 221, "bases": 0, "doc": 127}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 116, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 174, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 274, "bases": 0, "doc": 35}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 131, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.change_x_units": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"qualname": 6, "fullname": 12, "annotation": 0, "default_value": 0, "signature": 52, "bases": 0, "doc": 40}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"qualname": 6, "fullname": 12, "annotation": 0, "default_value": 0, "signature": 52, "bases": 0, "doc": 40}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"qualname": 7, "fullname": 13, "annotation": 0, "default_value": 0, "signature": 80, "bases": 0, "doc": 42}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"qualname": 7, "fullname": 13, "annotation": 0, "default_value": 0, "signature": 80, "bases": 0, "doc": 42}, "ramanchada2.spectrum.calibration.normalize": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.normalize.normalize": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 161, "bases": 0, "doc": 92}, "ramanchada2.spectrum.calibration.scale_xaxis": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 103, "bases": 0, "doc": 89}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 138, "bases": 0, "doc": 85}, "ramanchada2.spectrum.calibration.scale_yaxis": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 78, "bases": 0, "doc": 59}, "ramanchada2.spectrum.calibration.set_new_xaxis": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 112, "bases": 0, "doc": 73}, "ramanchada2.spectrum.creators": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.creators.from_cache_or_calc": {"qualname": 0, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"qualname": 1, "fullname": 8, "annotation": 0, "default_value": 13, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"qualname": 4, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 68, "bases": 0, "doc": 105}, "ramanchada2.spectrum.creators.from_chada": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 47, "bases": 0, "doc": 3}, "ramanchada2.spectrum.creators.from_delta_lines": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 169, "bases": 0, "doc": 182}, "ramanchada2.spectrum.creators.from_local_file": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 8}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 244, "bases": 0, "doc": 153}, "ramanchada2.spectrum.creators.from_simulation": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 9}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 396, "bases": 0, "doc": 236}, "ramanchada2.spectrum.creators.from_spectral_component_collection": {"qualname": 0, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"qualname": 4, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 47, "bases": 0, "doc": 44}, "ramanchada2.spectrum.creators.from_stream": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 295, "bases": 0, "doc": 3}, "ramanchada2.spectrum.creators.from_test_spe": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 8}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 23, "bases": 0, "doc": 74}, "ramanchada2.spectrum.creators.from_theoretical_lines": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 384, "bases": 0, "doc": 67}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure": {"qualname": 0, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"qualname": 4, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 38, "bases": 0, "doc": 73}, "ramanchada2.spectrum.filters": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.add_gaussian_noise": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 117, "bases": 0, "doc": 95}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift": {"qualname": 0, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"qualname": 5, "fullname": 12, "annotation": 0, "default_value": 0, "signature": 158, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"qualname": 4, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 206, "bases": 0, "doc": 180}, "ramanchada2.spectrum.filters.add_poisson_noise": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 96, "bases": 0, "doc": 103}, "ramanchada2.spectrum.filters.convolve": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.convolve.convolve": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 247, "bases": 0, "doc": 122}, "ramanchada2.spectrum.filters.drop_spikes": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 116, "bases": 0, "doc": 81}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 81}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 84}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 85}, "ramanchada2.spectrum.filters.dropna": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.dropna.dropna": {"qualname": 1, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 60, "bases": 0, "doc": 39}, "ramanchada2.spectrum.filters.moving_average": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 52}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 52}, "ramanchada2.spectrum.filters.moving_median": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 64}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 72, "bases": 0, "doc": 69}, "ramanchada2.spectrum.filters.pad_zeros": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 66, "bases": 0, "doc": 110}, "ramanchada2.spectrum.filters.resampling": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 430, "bases": 0, "doc": 167}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 185, "bases": 0, "doc": 167}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 235, "bases": 0, "doc": 139}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"qualname": 3, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 263, "bases": 0, "doc": 139}, "ramanchada2.spectrum.filters.sharpen_lines": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 301, "bases": 0, "doc": 104}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 77, "bases": 0, "doc": 66}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 121, "bases": 0, "doc": 91}, "ramanchada2.spectrum.filters.smoothing": {"qualname": 0, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"qualname": 2, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 173, "bases": 0, "doc": 80}, "ramanchada2.spectrum.filters.trim_axes": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 121, "bases": 0, "doc": 80}, "ramanchada2.spectrum.peaks": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.find_peaks": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 26, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 356, "bases": 0, "doc": 194}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 82, "bases": 0, "doc": 61}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 293, "bases": 0, "doc": 143}, "ramanchada2.spectrum.peaks.fit_peaks": {"qualname": 0, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"qualname": 1, "fullname": 6, "annotation": 0, "default_value": 11, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.fit_peaks.available_models": {"qualname": 2, "fullname": 7, "annotation": 0, "default_value": 23, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 24, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"qualname": 4, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 240, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 324, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"qualname": 3, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 110, "bases": 0, "doc": 73}, "ramanchada2.spectrum.peaks.get_fitted_peaks": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 12, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 111, "bases": 0, "doc": 148}, "ramanchada2.spectrum.spectrum": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.logger": {"qualname": 1, "fullname": 4, "annotation": 0, "default_value": 9, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum": {"qualname": 1, "fullname": 4, "annotation": 0, "default_value": 0, "signature": 0, "bases": 4, "doc": 16}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 244, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 47, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 21, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 21, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 28, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 61, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 49, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.x": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.y": {"qualname": 2, "fullname": 5, "annotation": 7, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 11, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 56, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 56, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.x_err": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.y_err": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"qualname": 2, "fullname": 5, "annotation": 7, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.result": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 45, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 60, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 72, "bases": 0, "doc": 17}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 72, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 106, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 71, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 143, "bases": 0, "doc": 165}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 108, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 78, "bases": 0, "doc": 59}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 161, "bases": 0, "doc": 92}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"qualname": 7, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 52, "bases": 0, "doc": 40}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"qualname": 7, "fullname": 10, "annotation": 0, "default_value": 0, "signature": 52, "bases": 0, "doc": 40}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"qualname": 8, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 80, "bases": 0, "doc": 42}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"qualname": 8, "fullname": 11, "annotation": 0, "default_value": 0, "signature": 80, "bases": 0, "doc": 42}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 221, "bases": 0, "doc": 127}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 116, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 174, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 274, "bases": 0, "doc": 35}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 131, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 112, "bases": 0, "doc": 73}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 103, "bases": 0, "doc": 89}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 138, "bases": 0, "doc": 85}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 68, "bases": 0, "doc": 105}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 47, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 169, "bases": 0, "doc": 182}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 244, "bases": 0, "doc": 153}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 396, "bases": 0, "doc": 236}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 47, "bases": 0, "doc": 44}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 295, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 23, "bases": 0, "doc": 74}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 384, "bases": 0, "doc": 67}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 38, "bases": 0, "doc": 73}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 52}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 52}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 117, "bases": 0, "doc": 95}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 96, "bases": 0, "doc": 103}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 247, "bases": 0, "doc": 122}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 301, "bases": 0, "doc": 104}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 77, "bases": 0, "doc": 66}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 121, "bases": 0, "doc": 91}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 116, "bases": 0, "doc": 81}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 81}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 84}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 85}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 113, "bases": 0, "doc": 64}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 72, "bases": 0, "doc": 69}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 121, "bases": 0, "doc": 80}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 206, "bases": 0, "doc": 180}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 430, "bases": 0, "doc": 167}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 185, "bases": 0, "doc": 167}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 235, "bases": 0, "doc": 139}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 263, "bases": 0, "doc": 139}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 66, "bases": 0, "doc": 110}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"qualname": 2, "fullname": 5, "annotation": 0, "default_value": 0, "signature": 60, "bases": 0, "doc": 39}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"qualname": 3, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 173, "bases": 0, "doc": 80}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 293, "bases": 0, "doc": 143}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 111, "bases": 0, "doc": 148}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 356, "bases": 0, "doc": 194}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"qualname": 5, "fullname": 8, "annotation": 0, "default_value": 0, "signature": 82, "bases": 0, "doc": 61}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 324, "bases": 0, "doc": 3}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"qualname": 4, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 110, "bases": 0, "doc": 73}, "ramanchada2.theoretical_lines": {"qualname": 0, "fullname": 3, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.theoretical_lines.model_from_lines": {"qualname": 0, "fullname": 6, "annotation": 0, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 144, "bases": 0, "doc": 3}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"qualname": 1, "fullname": 7, "annotation": 0, "default_value": 0, "signature": 0, "bases": 3, "doc": 390}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"qualname": 2, "fullname": 8, "annotation": 9, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"qualname": 2, "fullname": 8, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"qualname": 2, "fullname": 8, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"qualname": 2, "fullname": 8, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"qualname": 2, "fullname": 8, "annotation": 2, "default_value": 0, "signature": 0, "bases": 0, "doc": 3}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"qualname": 3, "fullname": 9, "annotation": 4, "default_value": 1, "signature": 0, "bases": 0, "doc": 18}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"qualname": 3, "fullname": 9, "annotation": 5, "default_value": 75, "signature": 0, "bases": 0, "doc": 35}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"qualname": 4, "fullname": 10, "annotation": 5, "default_value": 1, "signature": 0, "bases": 0, "doc": 16}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"qualname": 3, "fullname": 9, "annotation": 0, "default_value": 0, "signature": 77, "bases": 0, "doc": 3}}, "length": 702, "save": true}, "index": {"qualname": {"root": {"1": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 13}, "3": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1}}, "df": 4}}}}}}, "4": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}}, "df": 1}}}}}, "5": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "3": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"3": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}}, "df": 18, "d": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 3, "a": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}}, "df": 1}}}}}, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}}, "df": 1}}}}}}}}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}}, "df": 3}}}}}}}}, "f": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"tf": 1}}, "df": 2}, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.io.HSDS.visit_domain": {"tf": 1}}, "df": 1}}}}}, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 1}}, "df": 24}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}}, "df": 1}}}}}}}}}}}, "y": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 2}}}}}}}}}}, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1}}, "df": 1}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 1}}, "df": 8}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 2}}}}}}}}, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"tf": 1}}, "df": 1}}}}}}}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1}}, "df": 2}}}}, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}}, "df": 5, "s": {"docs": {"ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}}, "df": 5, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}}, "df": 7}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}}, "df": 7}}}}}}}}}}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}}}, "o": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}}, "df": 2, "n": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}}, "df": 2}}}}}, "l": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}}, "df": 1}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}}, "df": 2, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"tf": 1}}, "df": 1}}}}}, "l": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 2}}}, "g": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.HSDS.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1}}, "df": 9}}}}, "a": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}}, "df": 4, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}}, "df": 1}}}, "w": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 2}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}}, "df": 10}, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}}, "df": 4}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"tf": 1}}, "df": 2}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 3, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 1}}, "df": 5}}}}}}}}}}}}}}}}}}}}}}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1}}, "df": 4}}}}, "w": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"tf": 1}}, "df": 1}}}}, "e": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}}, "df": 1}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}}, "df": 9, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}}, "df": 1}}}}}}}}, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}}, "df": 6}}}}}}}}}}}}}}}}}}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 16, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"tf": 1}}, "df": 1}}, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.get_filters": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 2}}}}, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 4, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"tf": 1}}, "df": 1}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}}}}}}}}, "s": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}}, "df": 1}}}, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 9, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}}, "df": 16}}}}}}}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"2": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 1}}, "df": 1}}}, "docs": {}, "df": 0}}}, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}}, "df": 8}}}}}}}, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 18}}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}}, "df": 6}, "e": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 4}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1}}, "df": 3}}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 33}}}, "w": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}}, "df": 7, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"tf": 1}}, "df": 2}}}}, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}}, "df": 1}}, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1}}, "df": 2, "y": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}}, "df": 1}}}}}}, "u": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 2, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"tf": 1}}, "df": 4}}}}}}}}, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.get_filters": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 14, "y": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}}, "df": 1}}}}}}}}}}, "n": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}}, "df": 2, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}}, "df": 2}}}}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"tf": 1}}, "df": 1}}}}}}}, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}}, "df": 8}}}}, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 7}}}}}}}}, "p": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}}, "df": 2, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"tf": 1}}, "df": 1}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"tf": 1}}, "df": 1}}}}, "o": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}}, "df": 3, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"tf": 1}}, "df": 6, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}}, "df": 1, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.calibration_component.ProcessingModel": {"tf": 1}}, "df": 1}}}}}, "s": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 1}}, "df": 1}}}}}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"tf": 1}}, "df": 1}}}}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile": {"tf": 1}}, "df": 1}}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"tf": 1}}, "df": 1}}}}}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1}}, "df": 1}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}}, "df": 5}, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}}, "df": 6}}}}}}}}}, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1}}, "df": 2}}, "i": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}}, "df": 2}}}, "d": {"docs": {"ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 2}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}}, "df": 1}}, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 1}}}}}}}}}, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}}, "df": 8, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1}}, "df": 3, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 3}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}}, "df": 1}}}}}}}}}}}}, "p": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1}}, "df": 1}, "w": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}}, "df": 3}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}}, "df": 2}}}}}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.plottable.Plottable.plot": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}}, "df": 9, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.misc.plottable.Plottable.plot": {"tf": 1}}, "df": 2}}}}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 11, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 10}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}}, "df": 12}}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}}, "df": 22}}}}}}}}}}}}}}}}}}}}}, "r": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}}, "df": 1}}}}}}, "y": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}}, "df": 5}}}}}}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1}}, "df": 2}}}}}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 9}}}}}}}}}}}}, "w": {"docs": {"ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"tf": 1}}, "df": 1, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"tf": 1}}, "df": 7}}}}, "l": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1}}, "df": 15}, "a": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"tf": 1}}, "df": 2}}}}}}}}}}, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 1}}, "df": 2}}}, "e": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}}, "df": 1}}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}}, "df": 18}}, "w": {"docs": {"ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}}, "df": 2}}, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}}, "df": 2}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 9}}}, "m": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 16}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.matchsets.normalize_tuples": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 4}}}}}}}, "n": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}}, "df": 2}}}}}}}}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 11}}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1}}, "df": 4}}}, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 4}}}}}, "s": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.sanitize_key": {"tf": 1}}, "df": 1}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}}, "df": 1}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}}, "df": 2}, "g": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}}, "df": 2}}}}, "f": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}}, "df": 3}}}, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1}}, "df": 1}}}}}}}, "r": {"docs": {"ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 2}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}}, "df": 11, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_err": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_err": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.result": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 89, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 10, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}}, "df": 18}}}}}}}}}}}, "l": {"docs": {"ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 2, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}}, "df": 1, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1}}, "df": 7}}}}}}}}}}}}}}}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}}, "df": 4}}}}}}}}}, "p": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}}, "df": 9}}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}}, "df": 10}}}}}}}}}}}}}}}}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1}}}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 1}}, "df": 4}}}}}}}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}}, "df": 5}}}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 6}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 4}}}}}, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}}, "df": 1}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 2}}}}}}}}, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"tf": 1}}, "df": 1}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}}, "df": 2}}}}}}, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}}, "df": 5}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 1}}, "df": 7}}}}}}}}, "k": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"tf": 1}}, "df": 1}}}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}}, "df": 1}}}}, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 16}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 6}}}}}}}}}, "v": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.utils.svd.svd_solve": {"tf": 1}, "ramanchada2.misc.utils.svd.svd_inverse": {"tf": 1}}, "df": 2}}, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.svd.svd_solve": {"tf": 1}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}}, "df": 4}}}, "u": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}}, "df": 8}}}}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"2": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}}, "df": 1}, "3": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 7}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 2}}}}}}}}}, "k": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.io.HSDS.sanitize_key": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}}, "df": 1}}}, "w": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"tf": 1}}, "df": 2}}}}}}, "c": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}}, "df": 1, "h": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 1}}, "df": 3, "d": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1}}, "df": 2, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 2, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}}, "df": 4}}}}}}}}}}}}}}}}}}}}}}, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}}, "df": 1}}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"tf": 1}}, "df": 1}}}}}, "r": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}}, "df": 2}}}, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}}, "df": 2}}}}}, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}}, "df": 1}}}}}}, "s": {"docs": {}, "df": 0, "v": {"docs": {"ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1}}, "df": 4}}, "r": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}}, "df": 2}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}}, "df": 1}}}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"tf": null}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": null}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": null}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": null}}, "df": 4, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}}}}}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}}, "df": 11}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}}, "df": 1}}}, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 4}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 9}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 2}}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"tf": 1}}, "df": 4}}, "e": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}}, "df": 2}}}}}}}}}}, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"tf": 1}}, "df": 1}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 2}}}}}}}}, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1}}, "df": 1}}}}}}}}}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}}, "df": 2}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}}, "df": 2}}}}}, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}}, "df": 2, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}}, "df": 6}}}}}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 4}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}}, "df": 5, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 1}}, "df": 21}}}}}}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}}, "df": 14}}}}}}}}, "e": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}}, "df": 4}}}}}}, "c": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 3}}}, "m": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 13}, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1}}, "df": 2}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 1}}, "df": 5}}}}}}}}}}}}}}}, "p": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}}, "df": 9}}}}}}}}}}}}}}}}}, "c": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 1}}, "df": 5}}}}}}}}}}}}}}}}}}}}}}}}}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}}, "df": 10, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}}, "df": 1}, "c": {"docs": {"ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1}}, "df": 1}}}, "w": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1}}, "df": 1}}}, "o": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}}, "df": 1}}}}, "t": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}}, "df": 1}}}}}, "p": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1}}, "df": 1}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"tf": 1}}, "df": 1}}}}}}}, "f": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref": {"tf": 1}}, "df": 3, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1}}, "df": 3}}}}}}}, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"tf": 1}}, "df": 1, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"tf": 1}}, "df": 1}}}}}, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1}}, "df": 1}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 8}}}}}, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.result": {"tf": 1}}, "df": 1}}}}, "g": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}}, "df": 1}}}}}}}}, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}}, "df": 2}}}}}}, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1}}, "df": 1}}}, "a": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}}, "df": 1}, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 8}, "w": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"tf": 1}}, "df": 1}}}}, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}}, "df": 4}}}, "c": {"1": {"docs": {"ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 6}, "docs": {}, "df": 0}, "b": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 2}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.HSDS.visit_domain": {"tf": 1}}, "df": 1}}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 1}}, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1}}, "df": 1}}}}}}}, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}}, "df": 3}}}}}}}, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}}, "df": 1}}}}}}}}}, "b": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}}, "df": 1}, "y": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}}, "df": 5, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}}, "df": 1}}}}}}}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}}, "df": 2, "c": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.base_class.BaseClass": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}}, "df": 3}}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 11, "b": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}}, "df": 2}}}}}}}}}}}}}, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"tf": 1}}, "df": 2}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1}}, "df": 1}}, "y": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}}}}}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"tf": 1}}, "df": 5}}}}}}}}}, "u": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}}, "df": 1}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"tf": 1}}, "df": 1}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1}}, "df": 2, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper.MetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}, "h": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"tf": 1}}, "df": 3}}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}}, "df": 4}}}}}, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 48, "s": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 2}}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}}, "df": 12}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}}, "df": 2}}}}}}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}}, "df": 4}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}}, "df": 1}}, "x": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1}}, "df": 1, "x": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"tf": 1}}, "df": 1}}, "d": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 1}}, "df": 1}}, "w": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}}, "df": 1}, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1}}, "df": 1}, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {"ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 2, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}}, "df": 5}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 2}}}}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}}, "df": 4}}}}, "x": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"tf": 1}}, "df": 1}}, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}}}}}}}, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"tf": 1}}, "df": 5}}}}, "r": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"tf": 1}}, "df": 1}}}, "j": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}}, "df": 1}}}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": 1}}, "df": 1, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1}}, "df": 1}}}}}}}}}, "n": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.exceptions.InputParserError": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}}, "df": 18}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}}, "df": 1}}}}, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"tf": 1}}, "df": 1}}}}}}}}, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}}, "df": 1}}}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.svd.svd_inverse": {"tf": 1}}, "df": 1}}}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 2}}}}}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1}}, "df": 1}}}}}}}, "d": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1}}, "df": 2, "x": {"docs": {"ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}}, "df": 1}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 2}}}}, "t": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}}, "df": 1}}, "o": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 20}, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils.matchsets.normalize_tuples": {"tf": 1}}, "df": 1}}}}}, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}}, "df": 1}}}}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}}, "df": 2, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}}, "df": 4}}}}}}}}}}}}}}}}}}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}}, "df": 2}}}, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}}, "df": 2}}}, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}}, "df": 1}}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}}, "df": 3}}}, "w": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.boundaries": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}}, "df": 16}}}}}}}}}}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"tf": 1}}, "df": 2}}}}}}, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}}}}}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}}, "df": 1}}, "r": {"docs": {"ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 2, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.base_class.BaseClass.origin": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1}}, "df": 3}}}}}, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1}}, "df": 1}}}}}}}, "a": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"tf": 1}}, "df": 2, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 1}}, "df": 1}}}, "y": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}}, "df": 3}}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}}, "df": 1}}}}}, "d": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 14, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 2}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}}, "df": 3, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}}, "df": 4, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"tf": 1}}, "df": 2}}}}}}}}}, "r": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}}, "df": 1}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"2": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 3}}, "docs": {}, "df": 0}}}}, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}}, "df": 1}}}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}}, "df": 1}}}, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}}, "df": 1}}}}}, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}}, "df": 1, "o": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}}, "df": 1}}}}}, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}}, "df": 2}}}, "s": {"docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}}, "df": 3}}, "b": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 12}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}}, "df": 5}}}}}, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 2}}}}}}}}, "x": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}}, "df": 2}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_err": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_err": {"tf": 1}}, "df": 3, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}}, "df": 1}}}}}}}, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}}, "df": 1}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate": {"tf": 1}}, "df": 1}}}}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}}, "df": 5, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors": {"tf": 1}}, "df": 1}}}}}}}}, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 2}}}}}}}, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled": {"tf": 1}}, "df": 1}}}}}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"tf": 1}}, "df": 1}}}}}}}}, "x": {"0": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_err": {"tf": 1}}, "df": 6, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 6, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}}, "df": 11}}}}}}}}}}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 6}}}}}, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 2}}}}}, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_err": {"tf": 1}}, "df": 8, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}}, "df": 15}}}}}}}}}}, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}}, "df": 13}}}}}}}}}}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}}, "df": 2}}}}}, "h": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 2}}, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 4}}}}}, "fullname": {"root": {"1": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 13}, "3": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1}}, "df": 4}}}}}}, "4": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}}, "df": 1}}}}}, "5": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "3": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"3": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}}, "df": 18, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}}, "df": 1, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"2": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.auxiliary": {"tf": 1}, "ramanchada2.auxiliary.spectra": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filters": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}, "ramanchada2.io": {"tf": 1}, "ramanchada2.io.HSDS": {"tf": 1}, "ramanchada2.io.HSDS.logger": {"tf": 1}, "ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.HSDS.sanitize_key": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.io.HSDS.visit_domain": {"tf": 1}, "ramanchada2.io.experimental": {"tf": 1}, "ramanchada2.io.experimental.bw_format": {"tf": 1}, "ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}, "ramanchada2.io.experimental.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_spe": {"tf": 1}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1}, "ramanchada2.io.experimental.read_txt": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}, "ramanchada2.io.experimental.rruf_format": {"tf": 1}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1}, "ramanchada2.io.output": {"tf": 1}, "ramanchada2.io.output.write_csv": {"tf": 1}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1}, "ramanchada2.io.simulated": {"tf": 1}, "ramanchada2.io.simulated.crystal": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.io.simulated.vasp": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.misc": {"tf": 1}, "ramanchada2.misc.base_class": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}, "ramanchada2.misc.constants": {"tf": 1}, "ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}, "ramanchada2.misc.exceptions": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}, "ramanchada2.misc.plottable": {"tf": 1}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.misc.plottable.Plottable.plot": {"tf": 1}, "ramanchada2.misc.spectrum_deco": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_method": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 1}, "ramanchada2.misc.types": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}, "ramanchada2.misc.types.peak_candidates": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.positive_not_multiple": {"tf": 1}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.misc.utils": {"tf": 1}, "ramanchada2.misc.utils.argmin2d": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.misc.utils.matchsets": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.misc.utils.matchsets.normalize_tuples": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.misc.utils.svd": {"tf": 1}, "ramanchada2.misc.utils.svd.svd_solve": {"tf": 1}, "ramanchada2.misc.utils.svd.svd_inverse": {"tf": 1}, "ramanchada2.protocols": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.ProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.metadata_helper": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.spectraframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.boundaries": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}, "ramanchada2.spectral_components": {"tf": 1}, "ramanchada2.spectral_components.baseline": {"tf": 1}, "ramanchada2.spectral_components.baseline.analytical": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectrum": {"tf": 1}, "ramanchada2.spectrum.arithmetics": {"tf": 1}, "ramanchada2.spectrum.arithmetics.add": {"tf": 1}, "ramanchada2.spectrum.arithmetics.mul": {"tf": 1}, "ramanchada2.spectrum.arithmetics.sub": {"tf": 1}, "ramanchada2.spectrum.arithmetics.truediv": {"tf": 1}, "ramanchada2.spectrum.baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calc": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.calibration": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_err": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_err": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.result": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}, "ramanchada2.theoretical_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 702}, "docs": {}, "df": 0}}}}}, "s": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}}, "df": 6}}}}}}}}, "w": {"docs": {"ramanchada2.io.simulated.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1.4142135623730951}}, "df": 2}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_spe": {"tf": 1}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_txt": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.read_simulated_lines": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1.4142135623730951}}, "df": 14, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}}, "df": 18}}}, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}}, "df": 1}, "c": {"docs": {"ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1}}, "df": 1}}}, "w": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1}}, "df": 1}}}, "o": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}}, "df": 1}}}}, "t": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}}, "df": 1}}}}}, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"tf": 1}}, "df": 1, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.fit_peaks_result": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.result": {"tf": 1}}, "df": 18}}}, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"tf": 1}}, "df": 1}}}}}, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1}}, "df": 1}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.filters.resampling": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}}, "df": 5}}}, "e": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 8}}}}}}, "p": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1}}, "df": 1}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"tf": 1}}, "df": 1}}}}}}}, "f": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref": {"tf": 1}}, "df": 3, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1}}, "df": 3}}}}}}}, "g": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}}, "df": 1}}}}}}}}, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}}, "df": 2}}}}}}, "c": {"1": {"docs": {"ramanchada2.io.experimental.rc1_parser": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 32}, "docs": {}, "df": 0}, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.io.experimental.rruf_format": {"tf": 1}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1.4142135623730951}}, "df": 2}}}, "s": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 8}, "w": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"tf": 1}}, "df": 1}}}}, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}}, "df": 4}}}, "b": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 2}}}, "a": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"tf": 1}}, "df": 2, "u": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.auxiliary": {"tf": 1}, "ramanchada2.auxiliary.spectra": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filters": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}}, "df": 13}}}}}}}}, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 1}}, "df": 21}}}, "y": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}}, "df": 3}}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}}, "df": 1}}}}}, "d": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 1}, "ramanchada2.spectrum.arithmetics.add": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 20, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1.4142135623730951}}, "df": 3}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}}, "df": 3, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}}, "df": 4, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"tf": 1}}, "df": 2}}}}}}}}}, "r": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}}, "df": 1}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"2": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.utils.argmin2d": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 12}}, "docs": {}, "df": 0}}}}, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}}, "df": 1}}}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}}, "df": 1}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.arithmetics": {"tf": 1}, "ramanchada2.spectrum.arithmetics.add": {"tf": 1}, "ramanchada2.spectrum.arithmetics.mul": {"tf": 1}, "ramanchada2.spectrum.arithmetics.sub": {"tf": 1}, "ramanchada2.spectrum.arithmetics.truediv": {"tf": 1}}, "df": 5}}}}}}}}}}, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}}, "df": 1}}}}}, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}}, "df": 1, "o": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}}, "df": 1}}}}}, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}}, "df": 2}}}, "s": {"docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}}, "df": 3}}, "b": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 12}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}}, "df": 6}}}}}, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 2}}}}}}}}, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectral_components.baseline.analytical": {"tf": 1}}, "df": 1}}}}}}}}}, "x": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.filters.trim_axes": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}}, "df": 3}}}}, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.read_spe": {"tf": 1}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}}, "df": 13, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.auxiliary.spectra": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filters": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}}, "df": 12, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 29, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}}, "df": 18}}}}}}}}}}}, "l": {"docs": {"ramanchada2.spectral_components": {"tf": 1}, "ramanchada2.spectral_components.baseline": {"tf": 1}, "ramanchada2.spectral_components.baseline.analytical": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component_collection": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_peak": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 46, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}}, "df": 1, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1}}, "df": 7}}}}}}}}}}}}}}}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}}, "df": 4}}}}}}, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.spectrum_deco": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor": {"tf": 1.4142135623730951}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_filter": {"tf": 1.4142135623730951}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1.4142135623730951}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_method": {"tf": 1.4142135623730951}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}, "ramanchada2.misc.types.spectrum": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"tf": 1}, "ramanchada2.spectrum": {"tf": 1}, "ramanchada2.spectrum.arithmetics": {"tf": 1}, "ramanchada2.spectrum.arithmetics.add": {"tf": 1}, "ramanchada2.spectrum.arithmetics.mul": {"tf": 1}, "ramanchada2.spectrum.arithmetics.sub": {"tf": 1}, "ramanchada2.spectrum.arithmetics.truediv": {"tf": 1}, "ramanchada2.spectrum.baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calc": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.calibration": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.x": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.x_err": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_err": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.result": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.7320508075688772}}, "df": 271, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}}}}}}}}}, "p": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}}, "df": 9}}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}}, "df": 10}}}}}}}}}}}}}}}}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1}}}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 1}}, "df": 4}}}}}}}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}}, "df": 5}}}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.spectrum.filters.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 8}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 4}}}}}, "i": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}}, "df": 4, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.auxiliary.spectra.simulated": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}, "ramanchada2.io.simulated": {"tf": 1}, "ramanchada2.io.simulated.crystal": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.vasp": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 16}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.io.simulated.vasp.vasp_simulation_dat": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 5}}}}}}}}, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"tf": 1}}, "df": 1}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}}, "df": 2}}}}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.sanitize_key": {"tf": 1}}, "df": 1}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}}, "df": 1}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}}, "df": 2}, "g": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}}, "df": 2}}}}, "f": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}}, "df": 3}}}, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1}}, "df": 1}}}}}}}, "r": {"docs": {"ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.spectrum.creators.from_stream": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 3}}}}}, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}}, "df": 6}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 1}}, "df": 7}}}}}}}}, "k": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"tf": 1}}, "df": 1}}}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}}, "df": 1}}}}, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 16}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}}, "df": 4, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 6}}}}}}}}}, "v": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.utils.svd": {"tf": 1}, "ramanchada2.misc.utils.svd.svd_solve": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.svd.svd_inverse": {"tf": 1.4142135623730951}}, "df": 3}}, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.svd.svd_solve": {"tf": 1}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}}, "df": 4}}}, "u": {"docs": {}, "df": 0, "b": {"docs": {"ramanchada2.spectrum.arithmetics.sub": {"tf": 1}}, "df": 1, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}}, "df": 8}}}}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"2": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}}, "df": 1}, "3": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 9}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.filters.smoothing": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 3}}}}}}}}}, "d": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1.4142135623730951}}, "df": 6, "a": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}}, "df": 1, "s": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filters": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"tf": 1}}, "df": 8}, "docs": {}, "df": 0}, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}}, "df": 1}}}}}, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}}, "df": 1}}}}}}}}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}}, "df": 3}}}}}}}}, "f": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"tf": 1}}, "df": 2}, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.io.HSDS.visit_domain": {"tf": 1}}, "df": 1}}}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}}, "df": 4}}}}}, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}}, "df": 1}}}}}}}}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 1}}, "df": 24}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}}, "df": 1}}}}}, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.misc.spectrum_deco": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_method": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 1}}, "df": 13}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 1}}, "df": 8}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 2}}}}}}}}, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"tf": 1}}, "df": 1}}}}}}}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1}}, "df": 2}}}}, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.spectral_components.peak_profile.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}}, "df": 13, "s": {"docs": {"ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}}, "df": 30, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}}, "df": 7}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}}, "df": 7}}}}}}}}}}}}, "y": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1.4142135623730951}}, "df": 3}}}}}}}}}}, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1}}, "df": 1}}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.filters.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 4}}}, "o": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.spectrum.filters.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}}, "df": 6, "n": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.spectrum.filters.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}}, "df": 3}}}}}, "l": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}}, "df": 1}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}}, "df": 2, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"tf": 1}}, "df": 1}}}}}, "l": {"docs": {"ramanchada2.spectrum.creators.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}}, "g": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.HSDS.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1}}, "df": 9}}}}, "a": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}}, "df": 4, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}}, "df": 1}}}, "w": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 2}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.crystal.discrete_lines_out": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.read_simulated_lines": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.theoretical_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1.4142135623730951}}, "df": 32}, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}}, "df": 4}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"tf": 1}}, "df": 2}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 3, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 1}}, "df": 5}}}}}}}}}}}}}}}}}}}}}}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1}}, "df": 4}}}}, "w": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"tf": 1}}, "df": 1}}}}, "e": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}}, "df": 1}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}}, "df": 9, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}}, "df": 1}}}}}}}}, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}}, "df": 6}}}}}}}}}}}}}}}}}}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 18, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"tf": 1}}, "df": 1}}, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.get_filters": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.spectrum.filters": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}}, "df": 40}}}}, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 5, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"tf": 1}}, "df": 1}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}}}}}}}}, "s": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}}, "df": 1}}}, "t": {"docs": {"ramanchada2.misc.types.fit_peaks_result": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 31, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}}, "df": 16}}}}}}}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"2": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 1}}, "df": 1}}}, "docs": {}, "df": 0}}}, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}}, "df": 8}}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.peaks.get_fitted_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}}, "df": 3}}}}, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 18}}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}}, "df": 10}, "e": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 4}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.experimental.bw_format": {"tf": 1}, "ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}, "ramanchada2.io.experimental.rruf_format": {"tf": 1}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1.4142135623730951}}, "df": 14}}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_stream": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1.4142135623730951}}, "df": 55}}}, "w": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}}, "df": 7, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"tf": 1}}, "df": 2}}}}, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}}, "df": 1}}, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1}}, "df": 2, "y": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}}, "df": 1}}}}}}, "u": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 2, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"tf": 1}}, "df": 4}}}}}}}}, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.get_filters": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 17, "y": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}}, "df": 1}}}}}}}}}}, "n": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}}, "df": 2, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}}, "df": 2}}}}}}}, "g": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}}, "df": 4}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"tf": 1}}, "df": 1}}}}}}}, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectral_components.peak_profile.gauss": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}}, "df": 9, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}}, "df": 8}}}}, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 9}}}}}}}}, "p": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}}, "df": 2, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"tf": 1}}, "df": 1}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"tf": 1}}, "df": 1}}}}, "o": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}}, "df": 3, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"tf": 1}}, "df": 6, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 1}}, "df": 21}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.calibration_component.ProcessingModel": {"tf": 1}}, "df": 1}}}}}}}}}}}}, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.ProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.metadata_helper": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.spectraframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.boundaries": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}}, "df": 179}}}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"tf": 1}}, "df": 1}}}}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile": {"tf": 1}, "ramanchada2.spectral_components.peak_profile": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}}, "df": 21}}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"tf": 1}}, "df": 1}}}}}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1}}, "df": 1, "r": {"docs": {"ramanchada2.io.experimental.rc1_parser": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}}, "df": 23}}}, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.io.experimental.rc1_parser.third_party_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}}, "df": 4}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}}, "df": 5}, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}}, "df": 6}}}}}}}}}, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1}}, "df": 2}}, "i": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}}, "df": 2}}}, "d": {"docs": {"ramanchada2.spectrum.filters.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 3}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}}, "df": 1}}, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 1}}}}}}}}}, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}}, "df": 8, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1}}, "df": 3, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 3}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.positive_not_multiple": {"tf": 1}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}}, "df": 2, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}}, "df": 1}}}}}}}}}}}}, "p": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1}}, "df": 1}, "w": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}}, "df": 3}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}}, "df": 3}}}}}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.plottable.Plottable.plot": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}}, "df": 9, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.plottable": {"tf": 1}, "ramanchada2.misc.plottable.Plottable": {"tf": 1.4142135623730951}, "ramanchada2.misc.plottable.Plottable.plot": {"tf": 1.4142135623730951}}, "df": 3}}}}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.misc.types.peak_candidates": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.spectral_components.peak_profile": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 75, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.get_fitted_peaks": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 42}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}}, "df": 12}}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}}, "df": 22}}}}}}}}}}}}}}}}}}}}}, "r": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}}, "df": 1}}}}}}, "y": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.types.pydantic_base_model": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1}}, "df": 8}}}}}, "b": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}}, "df": 5}}}}}}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1}}, "df": 2}}}}}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 9}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.io": {"tf": 1}, "ramanchada2.io.HSDS": {"tf": 1}, "ramanchada2.io.HSDS.logger": {"tf": 1}, "ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.HSDS.sanitize_key": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.io.HSDS.visit_domain": {"tf": 1}, "ramanchada2.io.experimental": {"tf": 1}, "ramanchada2.io.experimental.bw_format": {"tf": 1}, "ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rc1_parser.third_party_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}, "ramanchada2.io.experimental.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_spe": {"tf": 1}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1}, "ramanchada2.io.experimental.read_txt": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}, "ramanchada2.io.experimental.rruf_format": {"tf": 1}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1}, "ramanchada2.io.output": {"tf": 1}, "ramanchada2.io.output.write_csv": {"tf": 1}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1}, "ramanchada2.io.simulated": {"tf": 1}, "ramanchada2.io.simulated.crystal": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.io.simulated.vasp": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 62}, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": 1}}, "df": 1, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1}}, "df": 1}}}}}}}}}, "n": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.exceptions.InputParserError": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}}, "df": 18}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}}, "df": 1}}}}, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"tf": 1}}, "df": 1}}}}}}}}, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}}, "df": 1}}}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.svd.svd_inverse": {"tf": 1}}, "df": 1}}}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 2}}}}}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1}}, "df": 1}}}}}}}, "d": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1}}, "df": 2, "x": {"docs": {"ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}}, "df": 1}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 6}}}}, "h": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.HSDS": {"tf": 1}, "ramanchada2.io.HSDS.logger": {"tf": 1}, "ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.HSDS.sanitize_key": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.io.HSDS.visit_domain": {"tf": 1}}, "df": 9}}}, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}}, "df": 15}}}}}, "d": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.creators.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3}}, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 4}}}, "w": {"docs": {"ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"tf": 1}}, "df": 1, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.output.write_csv": {"tf": 1}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"tf": 1}}, "df": 8}}}}, "l": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1}}, "df": 15}, "a": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"tf": 1}}, "df": 8}}}}}}}}}}, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}}, "df": 4, "x": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 1}}, "df": 2}}}, "e": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.io.experimental.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1.4142135623730951}}, "df": 2}}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}}, "df": 18}}, "w": {"docs": {"ramanchada2.spectrum.calibration.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}}, "df": 3}}, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}}, "df": 2}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 9}}}, "m": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 16}, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.positive_not_multiple": {"tf": 1}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}}, "df": 2}, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.matchsets.normalize_tuples": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 5}}}}}}}, "n": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}}, "df": 2}}}}}}}}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 14}}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1}}, "df": 4}}}, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectral_components.baseline.numerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}}, "df": 3}}}}}}}, "d": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 4}}}}}, "k": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.io.HSDS.sanitize_key": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}}, "df": 1}}}, "w": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"tf": 1}}, "df": 2}}}}}}, "c": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}}, "df": 1, "h": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 1}}, "df": 3, "d": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.spectrum.creators.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1}}, "df": 3, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 2, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}}, "df": 4}}}}}}}}}}}}}}}}}}}}}, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.calibration.change_x_units": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 5}}}}, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}}, "df": 1}}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"tf": 1}}, "df": 1}}}}}, "r": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}}, "df": 2}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.base_class": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}}, "df": 4}}}, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}}, "df": 2}}}}}, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}}, "df": 1}}}}}}, "s": {"docs": {}, "df": 0, "v": {"docs": {"ramanchada2.io.experimental.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1.4142135623730951}, "ramanchada2.io.output.write_csv": {"tf": 1}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1}}, "df": 6}}, "r": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.io.simulated.crystal": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.crystal.discrete_lines_out": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1.4142135623730951}}, "df": 5}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.spectrum.creators": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}}, "df": 22}}}}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.constants": {"tf": 1}, "ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 19}}}}, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor": {"tf": null}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"tf": null}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": null}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": null}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": null}}, "df": 5, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}}}}}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}}, "df": 11}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}}, "df": 1}}}, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 5}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 9}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_component": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.ProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 1}, "ramanchada2.spectral_components.spectral_component": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 37, "s": {"docs": {"ramanchada2.spectral_components": {"tf": 1}, "ramanchada2.spectral_components.baseline": {"tf": 1}, "ramanchada2.spectral_components.baseline.analytical": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}}, "df": 43}}}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"tf": 1}}, "df": 4}}, "e": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}}, "df": 2}}}}}}}}}}, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"tf": 1}}, "df": 1}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectral_components.spectral_component_collection": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 11}}}}}}}}, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1}}, "df": 1}}}}}}}}}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}}, "df": 2}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.calc.central_moments": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}}, "df": 3}}}}}, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}}, "df": 2, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}}, "df": 6}}}}}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 1}}, "df": 40}}}}}}}}, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 6}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}}, "df": 4, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.ProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}, "ramanchada2.spectrum.calibration": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}}, "df": 158, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 1}}, "df": 21}}}}}}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}}, "df": 14}}}}}}}}, "e": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}}, "df": 4}}}}}}, "c": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.spectrum.calc": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 8}}}, "m": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 13}, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1}}, "df": 2}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 1}}, "df": 5}}}}}}}}}}}}}}}, "p": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}}, "df": 9}}}}}}}}}}}}}}}}}, "c": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 1}}, "df": 5}}}}}}}}}}}}}}}}}}}}}}}}}}}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.HSDS.visit_domain": {"tf": 1}}, "df": 1}}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.io.simulated.vasp": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1.7320508075688772}}, "df": 3}}, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1}}, "df": 1}}}}}}}, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}}, "df": 3}}}}}}}, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectral_components.peak_profile.voigt": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}}, "df": 2, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}}, "df": 1}}}}}}}}}, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.io.experimental": {"tf": 1}, "ramanchada2.io.experimental.bw_format": {"tf": 1}, "ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}, "ramanchada2.io.experimental.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_spe": {"tf": 1}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1}, "ramanchada2.io.experimental.read_txt": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}, "ramanchada2.io.experimental.rruf_format": {"tf": 1}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1}}, "df": 36}}}}}}}}}, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.creators.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3}}}}}}, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.exceptions": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}}, "df": 4}}}}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}}, "df": 1}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate": {"tf": 1}}, "df": 1}}}}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}}, "df": 5, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors": {"tf": 1}}, "df": 1}}}}}}}}}, "r": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_err": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_err": {"tf": 1}}, "df": 3, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}}, "df": 1}}}}}}}, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled": {"tf": 1}}, "df": 1}}}}}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"tf": 1}}, "df": 1}}}}}}}}, "b": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.io.experimental.bw_format": {"tf": 1}, "ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1.4142135623730951}}, "df": 2}, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"tf": 1}}, "df": 1, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}}, "df": 6}}}}}, "y": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}}, "df": 30, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}}, "df": 1}}}}}}}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.base_class": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}}, "df": 16, "c": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.base_class.BaseClass": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}}, "df": 3}}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1}, "ramanchada2.spectral_components.baseline": {"tf": 1}, "ramanchada2.spectral_components.baseline.analytical": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.baseline.numerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectrum.baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.baseline_rc1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 24, "b": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}}, "df": 2}}}}}}}}}}}}}, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"tf": 1}}, "df": 2}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1}}, "df": 1}}, "y": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2, "g": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}}}}}}}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"tf": 1}}, "df": 5}}}}}}}}}, "u": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}}, "df": 1}}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1}}, "df": 2, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.types.spectrum.metadata": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.metadata_helper": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}}, "df": 27, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper.MetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}, "h": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_method": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"tf": 1}}, "df": 4}}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}}, "df": 5}}}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc": {"tf": 1}, "ramanchada2.misc.base_class": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}, "ramanchada2.misc.constants": {"tf": 1}, "ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}, "ramanchada2.misc.exceptions": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}, "ramanchada2.misc.plottable": {"tf": 1}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.misc.plottable.Plottable.plot": {"tf": 1}, "ramanchada2.misc.spectrum_deco": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_method": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 1}, "ramanchada2.misc.types": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}, "ramanchada2.misc.types.peak_candidates": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.positive_not_multiple": {"tf": 1}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.misc.utils": {"tf": 1}, "ramanchada2.misc.utils.argmin2d": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.misc.utils.matchsets": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.misc.utils.matchsets.normalize_tuples": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.misc.utils.svd": {"tf": 1}, "ramanchada2.misc.utils.svd.svd_solve": {"tf": 1}, "ramanchada2.misc.utils.svd.svd_inverse": {"tf": 1}}, "df": 167}}, "n": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.spectrum.baseline.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}}, "df": 5}}}}, "x": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"tf": 1}}, "df": 1}}, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}}}}}}, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1.4142135623730951}}, "df": 70, "s": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 2}}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.baseline.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}}, "df": 15}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calc.central_moments": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}}, "df": 3}}}}}}, "u": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.arithmetics.mul": {"tf": 1}}, "df": 1, "t": {"docs": {}, "df": 0, "i": {"docs": {"ramanchada2.spectrum.creators.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.positive_not_multiple": {"tf": 1}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}}, "df": 2}, "y": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}}, "df": 5}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 2}}}}}}}}}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}}, "df": 4, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils.matchsets": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.misc.utils.matchsets.normalize_tuples": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 7}}}}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}}, "df": 1}}, "x": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1}}, "df": 1, "x": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"tf": 1}}, "df": 1}}, "d": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 1}}, "df": 1}}, "w": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}}, "df": 1}, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1}}, "df": 1}}, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 10}}}}, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils": {"tf": 1}, "ramanchada2.misc.utils.argmin2d": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.misc.utils.matchsets": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.misc.utils.matchsets.normalize_tuples": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.misc.utils.svd": {"tf": 1}, "ramanchada2.misc.utils.svd.svd_solve": {"tf": 1}, "ramanchada2.misc.utils.svd.svd_inverse": {"tf": 1}}, "df": 23}}}}, "r": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"tf": 1}}, "df": 1}}}, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.io.experimental.rc1_parser.third_party_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}}, "df": 4}}}, "e": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.theoretical_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 16}}}}}}}}}}, "x": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}, "ramanchada2.io.experimental.read_txt": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1.4142135623730951}}, "df": 10}}, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}, "ramanchada2.misc.types.peak_candidates": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.positive_not_multiple": {"tf": 1}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}}, "df": 101}}}}, "o": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 22}, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils.matchsets.normalize_tuples": {"tf": 1}}, "df": 1}}}}}, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}}, "df": 1}}}}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}}, "df": 2, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}}, "df": 4}}}}}}}}}}}}}}}}}}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.creators.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}}, "df": 3}}}, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}}, "df": 2}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}}, "df": 4}}, "u": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {"ramanchada2.spectrum.arithmetics.truediv": {"tf": 1}}, "df": 1}}}}}}, "w": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.twinning": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.boundaries": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}}, "df": 17, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.boundaries": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}}, "df": 16}}}}}}}}}}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.twinned": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"tf": 1}}, "df": 2}}}}}}}, "j": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}}, "df": 1}}}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_out": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1.4142135623730951}}, "df": 2, "p": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.output": {"tf": 1}, "ramanchada2.io.output.write_csv": {"tf": 1}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1}}, "df": 3}}}}}, "r": {"docs": {"ramanchada2.spectrum.creators.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 4, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.base_class.BaseClass.origin": {"tf": 1}, "ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1}}, "df": 3}}}}}, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1}}, "df": 1}}}}}}}, "x": {"0": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.x_err": {"tf": 1}}, "df": 11, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 6, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 1}}, "df": 38, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}}, "df": 11}}}}}}}}}}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.scale_xaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 8}}}}}, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.spectrum.filters.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 3}}}}}, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_err": {"tf": 1}}, "df": 8, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}}, "df": 35, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}}, "df": 15}}}}}}}}}}, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}}, "df": 13}}}}}}}}}}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.scale_yaxis": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}}, "df": 3}}}}}}}, "annotation": {"root": {"0": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.misc.constants.NEON_WL": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 2}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 81, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 1}}}, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 18}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 9}}}}}}}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"6": {"4": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1}}, "df": 15}}}}}, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 2}}}}}}, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1}}, "df": 5, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 2.449489742783178}}, "df": 1}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1}}, "df": 8}}}}}, "p": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}}, "df": 1}}}}}}}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}}, "df": 1}}}}}}}}}}, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}}, "df": 2}}}, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1}}, "df": 5}}}}, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1}}, "df": 1}}}}}}}}}}, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1.7320508075688772}}, "df": 1}}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1}}, "df": 2}}}}}, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}}, "df": 1}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}}, "df": 1}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}}, "df": 1}}}}}}}}}}}, "y": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1}}, "df": 2}}, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}}, "df": 1}}}}}}}, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1.4142135623730951}}, "df": 2}, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1}}, "df": 1}}}}}}}}, "c": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 18}}}}}}}}, "p": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}}, "df": 6}}}}}}}}}}}}}}}}, "o": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}}, "df": 1, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 9}}}}}}}}}}}}}}}, "n": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}}, "df": 6, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}}, "df": 6}}}}}}}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}}, "df": 2}}}}}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}}, "df": 4}}}}}}}}}}}, "p": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 18}}}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}}, "df": 2, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}}, "df": 1}}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}}, "df": 1}}}}}}}}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}}, "df": 4}}}}}}}}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1}}, "df": 1, "[": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"2": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}}}}}}}}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}}, "df": 1}}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1}}, "df": 3}}}}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1}}, "df": 5}}}, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1}}, "df": 2}}}}}}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1}}, "df": 1, "[": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}}, "df": 2}}}}}}}, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}}, "df": 1, "[": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1}}, "df": 1}}}}}}}}}}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}}, "df": 4}}}}}}, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}}, "df": 1}}}}}}}}}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}}, "df": 1}}}, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1}}, "df": 1}}}}}}}}}}}}}, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1.4142135623730951}}, "df": 2}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1}}, "df": 1}}}}}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}}, "df": 2}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"2": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1}}, "df": 6}, "docs": {}, "df": 0}}}}}}}}}}, "x": {"2": {"7": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 2.449489742783178}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 2}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}}, "df": 2}}}}}, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1}}, "df": 4}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}}, "df": 2}}}}}, "o": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1}}, "df": 8}}}, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1}}, "df": 2}}}}}}}}}, "f": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1}}, "df": 3}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"tf": 1}}, "df": 1}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"2": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}}}}}}}}}}}}}}}}, "b": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1}}, "df": 4}}, "v": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1}}, "df": 1}}}}}}}, "default_value": {"root": {"0": {"0": {"6": {"0": {"1": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"2": {"7": {"2": {"1": {"0": {"4": {"8": {"7": {"0": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"3": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"8": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"4": {"5": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "1": {"0": {"9": {"4": {"0": {"9": {"1": {"9": {"0": {"0": {"2": {"7": {"3": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3}}, "df": 1}, "3": {"4": {"7": {"8": {"2": {"7": {"0": {"9": {"6": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"0": {"5": {"4": {"4": {"2": {"1": {"9": {"4": {"6": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"8": {"9": {"1": {"9": {"8": {"4": {"3": {"3": {"6": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"5": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"2": {"0": {"8": {"2": {"3": {"9": {"9": {"5": {"2": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"5": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"2": {"0": {"3": {"9": {"6": {"7": {"7": {"3": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"6": {"4": {"2": {"7": {"0": {"8": {"4": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"6": {"1": {"7": {"8": {"6": {"0": {"5": {"2": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"7": {"6": {"3": {"2": {"4": {"0": {"7": {"6": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4.58257569495584}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 2.23606797749979}}, "df": 2}, "2": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.8284271247461903}}, "df": 1}, "1": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"7": {"4": {"0": {"3": {"3": {"8": {"2": {"3": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3}}, "df": 1}, "3": {"0": {"2": {"2": {"1": {"0": {"9": {"3": {"5": {"2": {"1": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"2": {"9": {"6": {"3": {"8": {"2": {"1": {"7": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"4": {"2": {"7": {"4": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"4": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "5": {"8": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"2": {"0": {"3": {"0": {"8": {"9": {"8": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"0": {"1": {"3": {"6": {"0": {"5": {"4": {"4": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"1": {"5": {"1": {"4": {"6": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"9": {"0": {"6": {"7": {"8": {"2": {"2": {"9": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.3166247903554}}, "df": 1}, "4": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "1": {"5": {"6": {"3": {"5": {"4": {"2": {"2": {"2": {"1": {"1": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"3": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"3": {"2": {"9": {"0": {"6": {"5": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"0": {"6": {"3": {"5": {"8": {"2": {"1": {"6": {"9": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"8": {"0": {"2": {"1": {"2": {"0": {"7": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"3": {"6": {"1": {"4": {"7": {"5": {"2": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"1": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"5": {"4": {"2": {"4": {"4": {"2": {"4": {"1": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"4": {"4": {"8": {"8": {"2": {"0": {"7": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4}}, "df": 1}, "1": {"9": {"9": {"7": {"7": {"9": {"5": {"5": {"5": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"1": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "6": {"8": {"9": {"3": {"4": {"2": {"4": {"0": {"3": {"6": {"5": {"8": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"9": {"2": {"7": {"7": {"8": {"9": {"9": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"3": {"8": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"2": {"2": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"4": {"5": {"7": {"3": {"3": {"0": {"2": {"9": {"8": {"9": {"0": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"4": {"4": {"7": {"8": {"4": {"5": {"2": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"1": {"6": {"0": {"3": {"9": {"7": {"1": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"9": {"5": {"1": {"6": {"9": {"8": {"4": {"4": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"8": {"6": {"5": {"9": {"0": {"5": {"2": {"2": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"1": {"3": {"7": {"4": {"2": {"3": {"4": {"8": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "4": {"2": {"5": {"6": {"4": {"8": {"9": {"6": {"6": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"3": {"5": {"5": {"6": {"0": {"2": {"0": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"6": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"4": {"6": {"7": {"0": {"2": {"4": {"2": {"9": {"7": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"3": {"9": {"7": {"5": {"1": {"5": {"7": {"9": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"1": {"5": {"7": {"8": {"1": {"8": {"9": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"6": {"2": {"6": {"6": {"4": {"3": {"9": {"2": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"1": {"6": {"8": {"4": {"7": {"7": {"5": {"3": {"2": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"6": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"4": {"4": {"6": {"0": {"2": {"6": {"9": {"0": {"2": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"4": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"7": {"8": {"8": {"3": {"0": {"2": {"9": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"4": {"1": {"8": {"4": {"4": {"5": {"5": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"3": {"2": {"2": {"8": {"4": {"4": {"4": {"9": {"6": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"7": {"2": {"6": {"9": {"1": {"0": {"5": {"3": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"9": {"7": {"3": {"4": {"6": {"4": {"8": {"6": {"2": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"5": {"6": {"0": {"4": {"2": {"9": {"1": {"5": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 14.212670403551895}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 14.212670403551895}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 14.212670403551895}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 14.212670403551895}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 3.1622776601683795}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 3.1622776601683795}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 3}, "ramanchada2.misc.constants.NEON_WL": {"tf": 6.557438524302}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.4142135623730951}}, "df": 18}, "1": {"0": {"0": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 5, "x": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "1": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 9.695359714832659}, "ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 8.831760866327848}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 6.164414002968976}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 6.164414002968976}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 6.164414002968976}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 6.164414002968976}}, "df": 8, "m": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "x": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}, "x": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2}}, "df": 1}}, "2": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"1": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"3": {"6": {"8": {"5": {"2": {"9": {"9": {"7": {"2": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1, "m": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}}}, "7": {"2": {"2": {"1": {"0": {"0": {"6": {"5": {"6": {"4": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "6": {"4": {"8": {"4": {"4": {"5": {"7": {"5": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"2": {"8": {"5": {"3": {"0": {"8": {"9": {"8": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"4": {"3": {"5": {"3": {"7": {"4": {"1": {"4": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"3": {"6": {"1": {"8": {"1": {"9": {"2": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "4": {"0": {"9": {"1": {"9": {"0": {"3": {"7": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 3.4641016151377544}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 11, "s": {"docs": {}, "df": 0, "x": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}, "1": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "3": {"2": {"1": {"6": {"5": {"4": {"2": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "1": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"3": {"7": {"8": {"6": {"8": {"4": {"8": {"0": {"7": {"2": {"4": {"6": {"4": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "4": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"1": {"3": {"8": {"4": {"3": {"0": {"1": {"3": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "9": {"7": {"4": {"4": {"6": {"8": {"7": {"0": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "1": {"7": {"5": {"9": {"9": {"5": {"7": {"7": {"2": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"1": {"9": {"9": {"4": {"1": {"5": {"1": {"1": {"2": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "8": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "9": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 4, "/": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1.7320508075688772}}, "df": 3}}}}}}, "2": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}}}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 5.744562646538029}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.23606797749979}}, "df": 5}, "1": {"4": {"3": {"5": {"3": {"5": {"1": {"7": {"9": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "4": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"5": {"1": {"6": {"5": {"6": {"6": {"7": {"3": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"1": {"3": {"4": {"5": {"3": {"9": {"3": {"2": {"2": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"4": {"3": {"4": {"9": {"9": {"3": {"7": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"4": {"8": {"4": {"8": {"2": {"5": {"8": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "4": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"1": {"6": {"5": {"5": {"3": {"2": {"8": {"8": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "8": {"3": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"5": {"9": {"8": {"8": {"1": {"3": {"6": {"5": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"0": {"2": {"8": {"4": {"4": {"6": {"3": {"2": {"7": {"5": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"7": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"1": {"3": {"9": {"7": {"8": {"8": {"4": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 10}, "3": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "9": {"2": {"1": {"8": {"0": {"9": {"9": {"6": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.7320508075688772}}, "df": 5, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "1": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "2": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"3": {"3": {"9": {"2": {"2": {"4": {"6": {"2": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"1": {"5": {"0": {"1": {"4": {"3": {"2": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"4": {"1": {"3": {"9": {"3": {"2": {"6": {"5": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"6": {"8": {"4": {"7": {"6": {"4": {"9": {"3": {"3": {"2": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "2": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "3": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "6": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"7": {"5": {"5": {"6": {"9": {"8": {"4": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"4": {"5": {"0": {"0": {"3": {"7": {"7": {"2": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 10}, "4": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 2}, "1": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}}, "df": 1}, "2": {"2": {"3": {"1": {"9": {"4": {"7": {"4": {"8": {"3": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"9": {"0": {"6": {"0": {"8": {"2": {"2": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}}, "df": 1}, "3": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 2}, "4": {"4": {"2": {"0": {"1": {"3": {"1": {"2": {"9": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}}, "df": 1}, "5": {"0": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "2": {"2": {"0": {"7": {"7": {"5": {"7": {"4": {"8": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"8": {"1": {"9": {"2": {"5": {"5": {"4": {"2": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}}, "df": 1}, "6": {"5": {"8": {"5": {"8": {"8": {"8": {"1": {"2": {"6": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"4": {"3": {"5": {"7": {"6": {"9": {"6": {"5": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}}, "df": 1}, "7": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"9": {"6": {"2": {"0": {"2": {"8": {"9": {"9": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "5": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "x": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}, "docs": {}, "df": 0}, "3": {"6": {"2": {"0": {"2": {"5": {"5": {"9": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 6}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 3}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 3}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 3}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 3}}, "df": 5}, "1": {"1": {"3": {"5": {"0": {"7": {"8": {"1": {"8": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"7": {"6": {"5": {"3": {"2": {"7": {"9": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"4": {"9": {"3": {"2": {"3": {"8": {"5": {"6": {"4": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"1": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"1": {"6": {"0": {"4": {"0": {"2": {"2": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1, "m": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}}}, "5": {"5": {"6": {"9": {"5": {"7": {"9": {"2": {"2": {"9": {"2": {"9": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"8": {"1": {"9": {"7": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "8": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "9": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"0": {"0": {"2": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"4": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"0": {"9": {"4": {"5": {"8": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"0": {"0": {"9": {"7": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"0": {"3": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"0": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"6": {"3": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"3": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "4": {"6": {"2": {"5": {"8": {"5": {"0": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"7": {"7": {"8": {"4": {"7": {"9": {"0": {"1": {"5": {"4": {"6": {"9": {"2": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "4": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"3": {"6": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"0": {"0": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "9": {"1": {"3": {"5": {"9": {"3": {"1": {"3": {"9": {"3": {"2": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"3": {"7": {"4": {"1": {"7": {"9": {"4": {"3": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2.449489742783178}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 3}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 3}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 3}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 3}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 10, "s": {"docs": {}, "df": 0, "x": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}}}, "6": {"0": {"2": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "1": {"0": {"0": {"2": {"1": {"5": {"3": {"0": {"6": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.4142135623730951}}, "df": 2}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"5": {"3": {"2": {"8": {"7": {"9": {"8": {"1": {"8": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"3": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 2, "m": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}}}, "8": {"4": {"8": {"1": {"6": {"2": {"8": {"6": {"3": {"6": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 3}, "7": {"0": {"0": {"6": {"8": {"0": {"2": {"7": {"2": {"1": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"6": {"7": {"1": {"6": {"7": {"3": {"0": {"1": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 5}, "1": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 3}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"2": {"1": {"4": {"0": {"7": {"5": {"9": {"4": {"0": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"9": {"2": {"7": {"3": {"8": {"6": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "9": {"0": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"4": {"5": {"3": {"0": {"8": {"8": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"7": {"0": {"0": {"4": {"1": {"7": {"4": {"8": {"4": {"5": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "7": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.NEON_WL": {"tf": 2.449489742783178}}, "df": 6}, "8": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 4}, "9": {"3": {"8": {"7": {"6": {"4": {"6": {"1": {"4": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 5}, "1": {"7": {"7": {"5": {"8": {"9": {"7": {"1": {"8": {"4": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "4": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"7": {"7": {"5": {"7": {"0": {"9": {"8": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "6": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "7": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "8": {"1": {"8": {"3": {"8": {"0": {"7": {"1": {"9": {"1": {"7": {"7": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"4": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"2": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "7": {"8": {"5": {"1": {"1": {"8": {"5": {"3": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"7": {"1": {"9": {"9": {"1": {"2": {"4": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "7": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"7": {"6": {"1": {"9": {"0": {"4": {"7": {"6": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"1": {"1": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 3}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 3}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"6": {"0": {"8": {"5": {"6": {"2": {"3": {"8": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "9": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4.795831523312719}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 3.1622776601683795}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 3.1622776601683795}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 3.1622776601683795}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 8.602325267042627}, "ramanchada2.misc.constants.NEON_WL": {"tf": 5.744562646538029}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.4142135623730951}}, "df": 21}, "2": {"0": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1, "x": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}, "docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}}}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "3": {"3": {"9": {"9": {"6": {"1": {"1": {"8": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"1": {"7": {"7": {"3": {"8": {"0": {"2": {"1": {"5": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 4.123105625617661}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.8284271247461903}}, "df": 5}, "1": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "8": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"0": {"0": {"0": {"7": {"9": {"3": {"5": {"3": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"3": {"7": {"1": {"5": {"4": {"9": {"5": {"2": {"4": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "9": {"4": {"9": {"2": {"4": {"6": {"5": {"4": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "6": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"9": {"2": {"0": {"6": {"3": {"4": {"9": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"8": {"9": {"2": {"5": {"9": {"8": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "8": {"8": {"9": {"8": {"7": {"0": {"5": {"7": {"0": {"0": {"2": {"2": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"7": {"2": {"6": {"1": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"2": {"7": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4.47213595499958}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 3.872983346207417}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.23606797749979}}, "df": 6, "x": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 8.717797887081348}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 2.23606797749979}}, "df": 2}}, "1": {"0": {"0": {"6": {"5": {"6": {"4": {"5": {"5": {"1": {"4": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}}}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "1": {"7": {"7": {"9": {"4": {"3": {"6": {"1": {"8": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "4": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "6": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"7": {"0": {"0": {"8": {"0": {"8": {"5": {"5": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "7": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"8": {"7": {"0": {"7": {"4": {"8": {"2": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "8": {"1": {"8": {"3": {"8": {"0": {"7": {"4": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"9": {"6": {"5": {"2": {"8": {"8": {"7": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1, "x": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}, "docs": {}, "df": 0}, "8": {"8": {"9": {"8": {"7": {"0": {"6": {"2": {"1": {"6": {"4": {"7": {"3": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"6": {"8": {"8": {"7": {"1": {"4": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "3": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}}}, "4": {"2": {"0": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "5": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "6": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1, "m": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}}}, "8": {"7": {"7": {"8": {"1": {"4": {"6": {"3": {"6": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 3}, "3": {"0": {"3": {"5": {"6": {"5": {"7": {"9": {"3": {"6": {"2": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"8": {"7": {"6": {"6": {"5": {"8": {"0": {"2": {"3": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"2": {"8": {"4": {"2": {"1": {"0": {"7": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}, "3": {"0": {"5": {"1": {"6": {"9": {"1": {"7": {"2": {"3": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 3}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "4": {"1": {"3": {"5": {"6": {"6": {"7": {"3": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"5": {"8": {"8": {"1": {"9": {"8": {"1": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "6": {"0": {"2": {"8": {"5": {"2": {"5": {"5": {"5": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "1": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "1": {"2": {"5": {"5": {"3": {"7": {"3": {"0": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "3": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "2": {"0": {"7": {"5": {"4": {"4": {"8": {"2": {"1": {"4": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "9": {"2": {"5": {"5": {"2": {"8": {"5": {"5": {"7": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 3}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "5": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "7": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"2": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "9": {"1": {"2": {"8": {"0": {"2": {"9": {"7": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "8": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "7": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "x": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}, "docs": {}, "df": 0}}}}, "docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "x": {"3": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 5}, "1": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "6": {"4": {"1": {"1": {"3": {"7": {"8": {"3": {"4": {"7": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"0": {"3": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"0": {"0": {"6": {"8": {"0": {"2": {"7": {"2": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "4": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"3": {"8": {"9": {"0": {"8": {"1": {"7": {"2": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"0": {"5": {"0": {"4": {"9": {"7": {"5": {"5": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"2": {"3": {"5": {"8": {"2": {"7": {"6": {"6": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "7": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"2": {"0": {"5": {"6": {"8": {"7": {"9": {"6": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"6": {"8": {"2": {"3": {"6": {"9": {"8": {"8": {"8": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}, "s": {"docs": {}, "df": 0, "x": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}, "6": {"0": {"0": {"1": {"8": {"9": {"3": {"3": {"4": {"1": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"7": {"0": {"9": {"7": {"5": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"1": {"4": {"1": {"3": {"7": {"1": {"9": {"4": {"8": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "5": {"8": {"2": {"0": {"5": {"6": {"8": {"9": {"2": {"8": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "3": {"2": {"5": {"8": {"7": {"1": {"2": {"0": {"1": {"4": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"9": {"6": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"5": {"7": {"3": {"6": {"4": {"8": {"2": {"9": {"4": {"5": {"8": {"2": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"5": {"9": {"1": {"5": {"2": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"3": {"6": {"2": {"7": {"4": {"1": {"5": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"2": {"2": {"3": {"4": {"1": {"4": {"3": {"2": {"6": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"4": {"6": {"4": {"7": {"1": {"6": {"1": {"7": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 3}, "8": {"0": {"1": {"1": {"9": {"9": {"1": {"1": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"7": {"7": {"1": {"8": {"6": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"1": {"2": {"6": {"9": {"8": {"4": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "7": {"0": {"1": {"1": {"6": {"7": {"5": {"6": {"0": {"7": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "1": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"2": {"8": {"0": {"7": {"9": {"1": {"9": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "3": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"0": {"9": {"7": {"8": {"5": {"1": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"5": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "6": {"6": {"3": {"8": {"0": {"4": {"7": {"4": {"8": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "6": {"2": {"0": {"7": {"0": {"9": {"4": {"9": {"1": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"7": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "8": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 3}, "1": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "2": {"5": {"6": {"9": {"9": {"3": {"3": {"7": {"5": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"5": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "4": {"3": {"1": {"6": {"8": {"1": {"9": {"1": {"8": {"5": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"8": {"4": {"1": {"4": {"0": {"5": {"9": {"5": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 4}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "5": {"7": {"9": {"0": {"4": {"7": {"0": {"1": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"4": {"2": {"8": {"5": {"7": {"1": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1, "m": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}}}, "7": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "8": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "2": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "4": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"8": {"1": {"3": {"3": {"6": {"1": {"0": {"7": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "9": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "7": {"2": {"2": {"9": {"1": {"0": {"0": {"5": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2}}, "df": 1}, "2": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"1": {"7": {"3": {"5": {"0": {"4": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"5": {"8": {"3": {"5": {"6": {"6": {"9": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 2, "m": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}}}, "3": {"6": {"4": {"0": {"1": {"7": {"4": {"7": {"5": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"7": {"8": {"4": {"5": {"8": {"0": {"4": {"9": {"8": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"2": {"5": {"7": {"9": {"9": {"8": {"0": {"5": {"5": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"6": {"7": {"0": {"9": {"3": {"7": {"7": {"2": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "7": {"3": {"9": {"9": {"1": {"9": {"8": {"2": {"7": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "8": {"8": {"1": {"0": {"4": {"5": {"6": {"4": {"8": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.7320508075688772}}, "df": 3}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4.898979485566356}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.NEON_WL": {"tf": 3.3166247903554}}, "df": 16}, "3": {"0": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1, "x": {"3": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}, "9": {"4": {"6": {"6": {"7": {"0": {"8": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "x": {"7": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}, "3": {"4": {"3": {"8": {"6": {"7": {"2": {"2": {"6": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 3.7416573867739413}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2.449489742783178}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2.449489742783178}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2.449489742783178}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.449489742783178}}, "df": 5}, "1": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "6": {"9": {"7": {"9": {"2": {"1": {"4": {"5": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "3": {"8": {"8": {"1": {"3": {"5": {"0": {"5": {"8": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2.23606797749979}}, "df": 1}, "4": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "8": {"5": {"3": {"9": {"1": {"4": {"1": {"4": {"6": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"7": {"2": {"9": {"7": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "5": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "4": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2}}, "df": 1}, "6": {"2": {"6": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "7": {"1": {"9": {"3": {"6": {"7": {"0": {"9": {"7": {"9": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"4": {"7": {"3": {"4": {"8": {"6": {"4": {"8": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "8": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2.23606797749979}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 4.795831523312719}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 4}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 4}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 4}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 4}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 8}, "1": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "1": {"1": {"3": {"9": {"1": {"6": {"0": {"5": {"2": {"8": {"5": {"5": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"9": {"9": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"1": {"0": {"7": {"5": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"2": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "2": {"0": {"9": {"7": {"2": {"8": {"1": {"4": {"6": {"9": {"4": {"1": {"6": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"0": {"2": {"8": {"3": {"9": {"7": {"6": {"7": {"1": {"5": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"2": {"3": {"5": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"3": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"1": {"1": {"1": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"4": {"6": {"0": {"5": {"5": {"2": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "4": {"2": {"9": {"6": {"0": {"8": {"3": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "4": {"4": {"9": {"0": {"4": {"0": {"9": {"8": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "5": {"5": {"5": {"6": {"9": {"5": {"8": {"0": {"3": {"0": {"8": {"4": {"6": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"2": {"3": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "4": {"7": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.NEON_WL": {"tf": 2}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"7": {"0": {"3": {"9": {"1": {"8": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"1": {"8": {"8": {"0": {"7": {"1": {"9": {"4": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"1": {"1": {"6": {"1": {"4": {"5": {"4": {"5": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "7": {"2": {"8": {"6": {"6": {"5": {"2": {"0": {"6": {"8": {"5": {"4": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 3}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"0": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "1": {"4": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 3}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"3": {"4": {"3": {"6": {"4": {"1": {"5": {"2": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1, "x": {"4": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "1": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"4": {"6": {"2": {"0": {"0": {"4": {"1": {"7": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "2": {"8": {"6": {"9": {"7": {"8": {"9": {"7": {"2": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "3": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2}}, "df": 1}, "4": {"3": {"9": {"2": {"3": {"0": {"1": {"5": {"8": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"8": {"5": {"9": {"6": {"1": {"1": {"3": {"4": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "8": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "3": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "7": {"9": {"8": {"1": {"8": {"5": {"9": {"4": {"1": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"4": {"4": {"1": {"4": {"6": {"4": {"1": {"8": {"4": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"1": {"6": {"9": {"6": {"1": {"5": {"5": {"1": {"5": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "3": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"7": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "1": {"0": {"1": {"9": {"2": {"4": {"8": {"9": {"7": {"4": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"5": {"7": {"5": {"9": {"6": {"3": {"7": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "3": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"5": {"9": {"2": {"6": {"1": {"5": {"9": {"6": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "5": {"6": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "7": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2.449489742783178}}, "df": 1}, "7": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 3}, "5": {"7": {"2": {"6": {"4": {"5": {"1": {"4": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"6": {"8": {"4": {"8": {"0": {"7": {"2": {"7": {"5": {"8": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "8": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "9": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "4": {"0": {"1": {"3": {"6": {"0": {"5": {"4": {"4": {"2": {"1": {"6": {"9": {"2": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"2": {"0": {"9": {"7": {"1": {"7": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "1": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2.23606797749979}}, "df": 1}, "2": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 4}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"6": {"9": {"9": {"7": {"4": {"9": {"3": {"2": {"3": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"0": {"3": {"7": {"5": {"5": {"1": {"2": {"7": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"7": {"3": {"3": {"0": {"4": {"1": {"5": {"7": {"5": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "6": {"8": {"8": {"3": {"1": {"1": {"1": {"8": {"3": {"4": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "7": {"1": {"1": {"2": {"6": {"5": {"3": {"8": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"6": {"3": {"4": {"8": {"1": {"8": {"1": {"6": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "8": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "6": {"0": {"2": {"6": {"8": {"6": {"9": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "9": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "5": {"0": {"1": {"0": {"9": {"4": {"0": {"9": {"1": {"6": {"8": {"7": {"9": {"7": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 5}, "1": {"4": {"7": {"3": {"9": {"2": {"2": {"8": {"3": {"3": {"9": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"7": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"8": {"1": {"0": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"2": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"2": {"9": {"8": {"3": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"3": {"4": {"1": {"9": {"6": {"7": {"0": {"1": {"6": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"2": {"3": {"7": {"9": {"3": {"0": {"4": {"7": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "7": {"4": {"1": {"0": {"8": {"9": {"8": {"4": {"6": {"8": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"6": {"4": {"8": {"0": {"4": {"9": {"2": {"0": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "8": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "6": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"3": {"7": {"9": {"0": {"5": {"2": {"3": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"9": {"2": {"7": {"4": {"6": {"3": {"4": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"8": {"8": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"3": {"0": {"8": {"4": {"5": {"6": {"4": {"2": {"5": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "4": {"2": {"6": {"6": {"9": {"5": {"8": {"4": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"5": {"6": {"1": {"4": {"9": {"0": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"2": {"2": {"0": {"2": {"3": {"6": {"8": {"2": {"4": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 3}, "8": {"9": {"6": {"5": {"6": {"1": {"5": {"8": {"3": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "9": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "6": {"1": {"4": {"5": {"0": {"8": {"4": {"1": {"3": {"9": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"2": {"4": {"5": {"7": {"5": {"1": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 4}, "docs": {}, "df": 0}, "7": {"0": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"5": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"1": {"9": {"9": {"0": {"6": {"3": {"7": {"7": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"7": {"2": {"6": {"6": {"0": {"2": {"3": {"9": {"7": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "3": {"3": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"3": {"6": {"7": {"6": {"1": {"3": {"7": {"4": {"3": {"5": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"8": {"3": {"8": {"8": {"3": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"5": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"1": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"0": {"0": {"6": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"5": {"4": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "3": {"5": {"1": {"5": {"6": {"5": {"0": {"8": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"6": {"8": {"4": {"8": {"0": {"7": {"2": {"5": {"6": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"6": {"7": {"6": {"1": {"9": {"9": {"6": {"9": {"5": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"3": {"9": {"5": {"7": {"9": {"3": {"6": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"5": {"2": {"7": {"0": {"9": {"1": {"0": {"2": {"6": {"2": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}}}, "7": {"4": {"3": {"9": {"8": {"2": {"4": {"9": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"8": {"0": {"5": {"1": {"6": {"2": {"6": {"0": {"7": {"3": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"1": {"3": {"9": {"4": {"7": {"6": {"1": {"7": {"5": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "6": {"8": {"0": {"5": {"8": {"4": {"3": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "4": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "6": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "6": {"7": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"4": {"7": {"2": {"2": {"3": {"8": {"7": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"3": {"3": {"3": {"7": {"7": {"8": {"7": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"5": {"7": {"6": {"9": {"4": {"0": {"2": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "9": {"0": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "1": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "2": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"2": {"0": {"7": {"4": {"6": {"1": {"4": {"1": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "7": {"3": {"0": {"8": {"5": {"3": {"3": {"9": {"2": {"0": {"2": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "4": {"5": {"5": {"7": {"8": {"2": {"3": {"1": {"6": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "6": {"3": {"6": {"9": {"5": {"5": {"2": {"2": {"0": {"1": {"8": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"2": {"5": {"3": {"9": {"6": {"8": {"2": {"5": {"5": {"2": {"4": {"6": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"2": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"2": {"3": {"2": {"8": {"8": {"1": {"0": {"3": {"4": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "9": {"2": {"8": {"5": {"8": {"3": {"5": {"3": {"1": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4.47213595499958}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.PST_RS_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.NEON_WL": {"tf": 5.291502622129181}}, "df": 18}, "4": {"0": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1, "x": {"4": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}, "docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "x": {"4": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}, "3": {"2": {"1": {"3": {"3": {"5": {"8": {"8": {"6": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"4": {"0": {"6": {"3": {"3": {"3": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}}, "df": 5}, "1": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "3": {"5": {"4": {"5": {"7": {"1": {"1": {"3": {"6": {"0": {"3": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"7": {"3": {"9": {"0": {"2": {"0": {"7": {"8": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"3": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "4": {"2": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "7": {"1": {"5": {"6": {"4": {"5": {"2": {"3": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "7": {"2": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"8": {"0": {"6": {"6": {"1": {"8": {"9": {"6": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "1": {"6": {"3": {"2": {"6": {"5": {"3": {"0": {"6": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "8": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 2}, "7": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.872983346207417}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 3}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}}, "df": 6, "m": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "x": {"3": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}, "s": {"docs": {}, "df": 0, "x": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}}}, "1": {"1": {"1": {"5": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "7": {"9": {"6": {"2": {"3": {"5": {"0": {"0": {"7": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"7": {"5": {"4": {"9": {"2": {"3": {"4": {"1": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"6": {"9": {"3": {"1": {"3": {"8": {"5": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "6": {"2": {"8": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "7": {"8": {"7": {"9": {"6": {"3": {"5": {"9": {"1": {"8": {"4": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"4": {"3": {"1": {"0": {"7": {"2": {"2": {"0": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"3": {"0": {"6": {"2": {"7": {"1": {"5": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"1": {"3": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 4}, "2": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"0": {"9": {"1": {"0": {"5": {"9": {"9": {"1": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"7": {"2": {"6": {"0": {"0": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "8": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "3": {"1": {"8": {"9": {"1": {"6": {"4": {"7": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"5": {"9": {"5": {"6": {"9": {"3": {"8": {"9": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.1622776601683795}}, "df": 1, "m": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}}}, "3": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"8": {"2": {"6": {"0": {"3": {"2": {"0": {"3": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"7": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "8": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"4": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"4": {"6": {"1": {"2": {"4": {"1": {"4": {"0": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"9": {"9": {"7": {"5": {"5": {"1": {"1": {"0": {"0": {"2": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 4}, "8": {"3": {"0": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"3": {"9": {"2": {"6": {"1": {"1": {"8": {"3": {"9": {"2": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"9": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"2": {"4": {"9": {"4": {"5": {"2": {"9": {"4": {"1": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "4": {"0": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "1": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 3}, "7": {"5": {"6": {"5": {"8": {"1": {"4": {"3": {"4": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"8": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"2": {"1": {"2": {"9": {"8": {"2": {"1": {"1": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "3": {"5": {"9": {"5": {"4": {"0": {"1": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"4": {"5": {"1": {"1": {"3": {"1": {"4": {"3": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "8": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "3": {"0": {"5": {"6": {"5": {"7": {"4": {"0": {"4": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"9": {"3": {"0": {"4": {"4": {"5": {"8": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "4": {"3": {"4": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "4": {"4": {"4": {"4": {"4": {"4": {"4": {"4": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"3": {"8": {"5": {"2": {"5": {"4": {"3": {"1": {"4": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "7": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"0": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}}, "df": 2}, "2": {"2": {"2": {"2": {"0": {"3": {"4": {"7": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"6": {"5": {"8": {"6": {"4": {"3": {"3": {"2": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"8": {"7": {"7": {"5": {"6": {"3": {"9": {"0": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"3": {"3": {"0": {"4": {"1": {"5": {"7": {"5": {"4": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 2}, "ramanchada2.misc.constants.NEON_WL": {"tf": 2}}, "df": 3}, "6": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"2": {"7": {"1": {"4": {"3": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"3": {"3": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"4": {"8": {"4": {"3": {"3": {"0": {"9": {"6": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"1": {"8": {"4": {"2": {"8": {"5": {"2": {"6": {"3": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"2": {"0": {"1": {"8": {"1": {"4": {"0": {"5": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"3": {"6": {"4": {"7": {"1": {"3": {"2": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"7": {"0": {"9": {"6": {"8": {"7": {"5": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"9": {"3": {"2": {"5": {"6": {"8": {"8": {"5": {"1": {"7": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"8": {"4": {"1": {"3": {"0": {"7": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "8": {"6": {"4": {"3": {"1": {"0": {"5": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1, "m": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}}}, "7": {"0": {"0": {"9": {"2": {"6": {"6": {"4": {"8": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "4": {"5": {"9": {"5": {"1": {"8": {"5": {"9": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "1": {"6": {"5": {"5": {"3": {"2": {"8": {"7": {"9": {"8": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"5": {"7": {"6": {"5": {"2": {"2": {"5": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}}, "df": 1}, "3": {"3": {"3": {"5": {"4": {"3": {"7": {"0": {"4": {"6": {"3": {"0": {"9": {"8": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"6": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "7": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"8": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"2": {"2": {"9": {"0": {"2": {"4": {"9": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"1": {"9": {"0": {"4": {"7": {"5": {"9": {"6": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"8": {"3": {"5": {"3": {"7": {"1": {"1": {"0": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "9": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"0": {"0": {"8": {"9": {"4": {"3": {"1": {"7": {"2": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "2": {"2": {"9": {"7": {"9": {"7": {"3": {"3": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"7": {"6": {"9": {"0": {"1": {"2": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"4": {"0": {"0": {"4": {"3": {"7": {"6": {"3": {"6": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"2": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"1": {"9": {"7": {"7": {"0": {"1": {"7": {"5": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "5": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"9": {"6": {"8": {"3": {"4": {"3": {"2": {"0": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"6": {"0": {"7": {"7": {"0": {"9": {"7": {"5": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"2": {"6": {"6": {"0": {"1": {"4": {"5": {"4": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"5": {"2": {"5": {"0": {"9": {"6": {"6": {"8": {"4": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"5": {"1": {"0": {"5": {"7": {"1": {"1": {"5": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"1": {"1": {"6": {"3": {"7": {"3": {"0": {"6": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"1": {"5": {"5": {"7": {"0": {"6": {"9": {"5": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"3": {"2": {"9": {"9": {"2": {"7": {"0": {"3": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"1": {"3": {"5": {"6": {"6": {"7": {"3": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"4": {"0": {"6": {"1": {"9": {"6": {"1": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "3": {"4": {"8": {"8": {"7": {"7": {"6": {"6": {"5": {"5": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"1": {"6": {"7": {"6": {"0": {"1": {"4": {"0": {"1": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"6": {"5": {"6": {"1": {"0": {"4": {"9": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"1": {"9": {"5": {"8": {"0": {"0": {"9": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"3": {"0": {"6": {"9": {"4": {"6": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"6": {"6": {"2": {"1": {"3": {"1": {"5": {"1": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"5": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4.47213595499958}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.PST_RS_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 2.449489742783178}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 2.449489742783178}, "ramanchada2.misc.constants.NEON_WL": {"tf": 3}}, "df": 13}, "5": {"0": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1, "x": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}, "docs": {}, "df": 0}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2}}, "df": 1}, "1": {"0": {"9": {"4": {"0": {"9": {"1": {"8": {"1": {"3": {"2": {"0": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"1": {"9": {"9": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"3": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"4": {"1": {"8": {"4": {"6": {"0": {"2": {"4": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"1": {"2": {"5": {"3": {"3": {"1": {"4": {"6": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"7": {"2": {"7": {"7": {"7": {"5": {"7": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"4": {"0": {"1": {"3": {"6": {"0": {"1": {"1": {"2": {"8": {"1": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"7": {"7": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"2": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "8": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"4": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"2": {"8": {"9": {"0": {"5": {"0": {"1": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"4": {"7": {"0": {"4": {"5": {"8": {"7": {"7": {"8": {"2": {"2": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"5": {"0": {"8": {"5": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"3": {"4": {"9": {"8": {"8": {"7": {"9": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"5": {"3": {"0": {"8": {"8": {"1": {"7": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 5.196152422706632}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 5.0990195135927845}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 5.0990195135927845}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 5.0990195135927845}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 5.0990195135927845}}, "df": 5, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "1": {"0": {"3": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"0": {"8": {"7": {"9": {"9": {"0": {"2": {"1": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"6": {"0": {"7": {"1": {"8": {"9": {"8": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"7": {"1": {"6": {"5": {"5": {"3": {"2": {"8": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"0": {"4": {"2": {"2": {"8": {"4": {"6": {"3": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 6}, "5": {"8": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"6": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "9": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"1": {"1": {"9": {"5": {"9": {"6": {"0": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"0": {"7": {"8": {"7": {"7": {"4": {"6": {"1": {"7": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"1": {"6": {"4": {"1": {"2": {"0": {"9": {"1": {"3": {"9": {"6": {"8": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"0": {"8": {"0": {"6": {"0": {"5": {"8": {"6": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"0": {"0": {"7": {"9": {"1": {"3": {"5": {"1": {"2": {"4": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"3": {"5": {"6": {"8": {"9": {"4": {"9": {"1": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"6": {"4": {"8": {"0": {"3": {"5": {"9": {"5": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"9": {"2": {"2": {"2": {"3": {"7": {"1": {"8": {"1": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 5.656854249492381}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 6, "n": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}}}, "3": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"8": {"6": {"7": {"5": {"3": {"9": {"8": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 6}, "4": {"3": {"4": {"4": {"4": {"0": {"1": {"3": {"4": {"8": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1.4142135623730951}}, "df": 4}, "5": {"1": {"4": {"7": {"3": {"8": {"1": {"4": {"1": {"8": {"9": {"6": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"8": {"6": {"2": {"1": {"2": {"9": {"3": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "7": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"8": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"9": {"5": {"4": {"5": {"6": {"7": {"4": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"0": {"2": {"9": {"6": {"2": {"6": {"5": {"1": {"4": {"9": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "1": {"7": {"4": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"5": {"0": {"1": {"1": {"3": {"3": {"7": {"8": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "4": {"8": {"5": {"7": {"7": {"6": {"8": {"0": {"5": {"2": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "6": {"5": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"3": {"1": {"2": {"5": {"7": {"3": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "9": {"7": {"7": {"6": {"6": {"4": {"0": {"1": {"4": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "2": {"5": {"0": {"4": {"4": {"6": {"0": {"0": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"1": {"5": {"9": {"9": {"9": {"4": {"9": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "5": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"2": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"9": {"5": {"4": {"4": {"1": {"6": {"2": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"6": {"7": {"2": {"3": {"1": {"6": {"1": {"2": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"2": {"8": {"7": {"9": {"8": {"1": {"8": {"5": {"9": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "5": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "7": {"1": {"0": {"4": {"1": {"7": {"8": {"7": {"0": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"6": {"3": {"1": {"9": {"8": {"1": {"5": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"5": {"2": {"2": {"6": {"4": {"7": {"8": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"1": {"2": {"4": {"3": {"2": {"6": {"1": {"7": {"2": {"0": {"0": {"7": {"7": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"0": {"2": {"6": {"7": {"8": {"6": {"1": {"4": {"1": {"4": {"9": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"2": {"7": {"0": {"3": {"2": {"9": {"9": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"5": {"5": {"1": {"4": {"2": {"2": {"3": {"1": {"9": {"6": {"8": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"1": {"7": {"7": {"0": {"9": {"0": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"1": {"6": {"2": {"5": {"1": {"1": {"8": {"3": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "6": {"5": {"8": {"2": {"8": {"0": {"8": {"9": {"5": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"9": {"3": {"4": {"2": {"4": {"0": {"3": {"6": {"3": {"5": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"6": {"3": {"0": {"7": {"5": {"5": {"9": {"1": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"9": {"2": {"7": {"7": {"8": {"9": {"9": {"3": {"4": {"3": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"5": {"1": {"3": {"5": {"4": {"4": {"1": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "7": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "2": {"5": {"1": {"9": {"4": {"4": {"1": {"4": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "2": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"0": {"4": {"1": {"5": {"7": {"5": {"4": {"9": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"3": {"7": {"4": {"4": {"2": {"4": {"2": {"3": {"1": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "6": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "5": {"4": {"9": {"2": {"3": {"4": {"1": {"3": {"5": {"6": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"6": {"4": {"8": {"8": {"9": {"0": {"2": {"8": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"4": {"2": {"6": {"7": {"0": {"4": {"2": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "7": {"3": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "4": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "7": {"8": {"4": {"7": {"8": {"9": {"4": {"3": {"8": {"4": {"8": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"1": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "7": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "4": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"3": {"3": {"9": {"2": {"5": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "8": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"1": {"9": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"9": {"7": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"5": {"2": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "7": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.NEON_WL": {"tf": 2.449489742783178}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"7": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"6": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "1": {"2": {"5": {"5": {"9": {"1": {"6": {"6": {"9": {"2": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"2": {"8": {"3": {"2": {"8": {"5": {"3": {"4": {"8": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"6": {"6": {"4": {"3": {"9": {"9": {"0": {"9": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "4": {"8": {"2": {"9": {"3": {"8": {"6": {"5": {"1": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"1": {"2": {"3": {"0": {"4": {"6": {"0": {"6": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"5": {"4": {"2": {"1": {"4": {"9": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "8": {"1": {"8": {"9": {"9": {"8": {"8": {"8": {"1": {"4": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "9": {"5": {"6": {"9": {"1": {"6": {"0": {"9": {"9": {"7": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 2}}, "df": 8}, "2": {"2": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"7": {"8": {"7": {"4": {"2": {"8": {"1": {"1": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "6": {"5": {"0": {"4": {"1": {"8": {"5": {"4": {"0": {"6": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "7": {"8": {"1": {"5": {"6": {"7": {"9": {"2": {"3": {"4": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "9": {"0": {"7": {"6": {"0": {"8": {"4": {"4": {"5": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"6": {"2": {"3": {"6": {"3": {"2": {"3": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4.47213595499958}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.misc.constants.PST_RS_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 2}, "ramanchada2.misc.constants.NEON_WL": {"tf": 3.4641016151377544}}, "df": 14, "m": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "x": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}, "s": {"docs": {}, "df": 0, "x": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}, "a": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 7.0710678118654755}}, "df": 1}}, "6": {"0": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "x": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}}}}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 5}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 2}}, "df": 2, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1, "x": {"4": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.449489742783178}}, "df": 1}, "5": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 5}}, "df": 1}}}, "docs": {}, "df": 0}}}}, "2": {"4": {"4": {"0": {"9": {"4": {"3": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}}, "df": 5}, "1": {"0": {"4": {"6": {"7": {"8": {"3": {"2": {"6": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "3": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 3}, "4": {"1": {"4": {"8": {"1": {"1": {"5": {"5": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"7": {"2": {"8": {"1": {"0": {"8": {"4": {"1": {"8": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"1": {"2": {"6": {"9": {"1": {"4": {"6": {"6": {"0": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"1": {"7": {"2": {"4": {"2": {"6": {"4": {"8": {"6": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "8": {"5": {"4": {"6": {"9": {"3": {"0": {"3": {"3": {"1": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"8": {"4": {"2": {"9": {"8": {"1": {"6": {"9": {"8": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"9": {"7": {"7": {"3": {"2": {"4": {"2": {"6": {"7": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4.47213595499958}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 3.872983346207417}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 3.3166247903554}}, "df": 6}, "1": {"0": {"6": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"6": {"3": {"3": {"6": {"2": {"6": {"4": {"4": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"0": {"2": {"4": {"5": {"5": {"0": {"8": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "4": {"5": {"8": {"5": {"7": {"3": {"8": {"3": {"6": {"2": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "6": {"3": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "8": {"1": {"0": {"1": {"8": {"8": {"9": {"8": {"5": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "docs": {}, "df": 0}, "2": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "1": {"4": {"4": {"4": {"2": {"0": {"1": {"3": {"1": {"2": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"3": {"3": {"3": {"5": {"4": {"2": {"2": {"2": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "2": {"2": {"3": {"3": {"1": {"2": {"1": {"9": {"1": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"7": {"4": {"5": {"5": {"4": {"1": {"3": {"5": {"7": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"4": {"8": {"5": {"0": {"1": {"1": {"0": {"7": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"2": {"0": {"5": {"6": {"8": {"7": {"5": {"9": {"4": {"4": {"7": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"4": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "8": {"1": {"1": {"7": {"9": {"1": {"3": {"8": {"3": {"3": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"6": {"3": {"8": {"7": {"7": {"9": {"6": {"6": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 7}, "3": {"4": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.7320508075688772}}, "df": 11}, "4": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"7": {"3": {"3": {"0": {"4": {"1": {"2": {"5": {"9": {"5": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"2": {"0": {"6": {"3": {"4": {"9": {"2": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"0": {"1": {"8": {"0": {"3": {"5": {"2": {"8": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"8": {"8": {"1": {"7": {"8": {"8": {"5": {"6": {"5": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"4": {"4": {"1": {"5": {"3": {"8": {"7": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.7320508075688772}}, "df": 9}, "9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "4": {"0": {"1": {"1": {"3": {"2": {"8": {"4": {"6": {"2": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "6": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.7320508075688772}}, "df": 10}, "1": {"0": {"4": {"2": {"2": {"6": {"2": {"0": {"9": {"4": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "2": {"9": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 3}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "5": {"3": {"1": {"3": {"9": {"7": {"9": {"1": {"7": {"3": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"1": {"0": {"6": {"7": {"3": {"3": {"8": {"8": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "6": {"7": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.7320508075688772}}, "df": 8}, "2": {"5": {"9": {"3": {"9": {"9": {"9": {"2": {"2": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "8": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.7320508075688772}}, "df": 8}, "5": {"4": {"7": {"1": {"5": {"4": {"8": {"9": {"5": {"3": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"4": {"5": {"5": {"1": {"4": {"2": {"2": {"3": {"1": {"7": {"8": {"4": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"0": {"7": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"7": {"1": {"8": {"5": {"3": {"3": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"1": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.7320508075688772}}, "df": 8}, "docs": {}, "df": 0}, "6": {"0": {"7": {"7": {"6": {"2": {"7": {"0": {"1": {"1": {"6": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"1": {"1": {"1": {"4": {"8": {"2": {"7": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"4": {"2": {"5": {"2": {"7": {"0": {"3": {"2": {"3": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"2": {"4": {"7": {"3": {"9": {"6": {"6": {"5": {"5": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"7": {"8": {"0": {"9": {"0": {"9": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"4": {"3": {"7": {"6": {"4": {"2": {"3": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"7": {"7": {"6": {"0": {"5": {"3": {"1": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.7320508075688772}}, "df": 6}, "7": {"4": {"2": {"2": {"7": {"3": {"6": {"0": {"0": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.7320508075688772}}, "df": 8}, "8": {"1": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "2": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "9": {"3": {"4": {"2": {"1": {"9": {"5": {"7": {"1": {"0": {"0": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"7": {"2": {"6": {"9": {"6": {"3": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"0": {"3": {"4": {"8": {"0": {"5": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "6": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"8": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"9": {"7": {"6": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"1": {"5": {"7": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"6": {"8": {"6": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"1": {"5": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "2": {"9": {"6": {"3": {"0": {"7": {"9": {"8": {"3": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"6": {"2": {"5": {"4": {"3": {"8": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"8": {"9": {"1": {"1": {"9": {"3": {"1": {"8": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.7320508075688772}}, "df": 8}, "5": {"7": {"3": {"6": {"9": {"6": {"1": {"4": {"2": {"4": {"8": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"4": {"6": {"1": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"9": {"0": {"9": {"1": {"3": {"2": {"0": {"4": {"8": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"2": {"2": {"6": {"2": {"5": {"4": {"2": {"8": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"7": {"9": {"2": {"0": {"3": {"5": {"6": {"0": {"7": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"4": {"3": {"3": {"5": {"6": {"4": {"4": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"2": {"7": {"2": {"0": {"4": {"2": {"7": {"3": {"4": {"2": {"3": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"4": {"0": {"8": {"0": {"1": {"5": {"1": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"1": {"1": {"4": {"3": {"7": {"7": {"2": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"5": {"3": {"9": {"6": {"7": {"2": {"9": {"0": {"8": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"3": {"3": {"4": {"7": {"9": {"2": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"1": {"8": {"0": {"8": {"1": {"4": {"1": {"3": {"6": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"1": {"2": {"2": {"1": {"5": {"6": {"9": {"3": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"3": {"8": {"9": {"7": {"1": {"2": {"8": {"4": {"3": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"7": {"2": {"6": {"9": {"0": {"2": {"2": {"8": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"0": {"7": {"4": {"8": {"2": {"9": {"9": {"3": {"1": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"2": {"2": {"9": {"7": {"2": {"5": {"4": {"6": {"5": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"5": {"6": {"0": {"0": {"1": {"4": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"2": {"7": {"7": {"8": {"9": {"9": {"3": {"4": {"3": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "4": {"4": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"4": {"2": {"4": {"0": {"3": {"5": {"3": {"8": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"2": {"9": {"7": {"7": {"2": {"9": {"7": {"3": {"4": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"3": {"2": {"5": {"5": {"9": {"9": {"1": {"8": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"5": {"2": {"6": {"2": {"0": {"8": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "4": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"1": {"2": {"4": {"5": {"6": {"3": {"5": {"1": {"1": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"0": {"2": {"0": {"7": {"5": {"8": {"6": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "7": {"8": {"6": {"3": {"1": {"0": {"1": {"0": {"4": {"6": {"4": {"3": {"7": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"3": {"9": {"3": {"6": {"8": {"4": {"9": {"5": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 3}}, "df": 14}, "7": {"0": {"0": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 5}}, "df": 1, "m": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "x": {"5": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 5}}, "df": 1}}}, "docs": {}, "df": 0}}}}, "2": {"1": {"8": {"8": {"1": {"8": {"3": {"8": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"8": {"0": {"2": {"7": {"1": {"7": {"2": {"7": {"9": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"7": {"8": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"3": {"9": {"5": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 5}, "1": {"3": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "3": {"6": {"9": {"2": {"0": {"1": {"6": {"4": {"0": {"8": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "4": {"1": {"1": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 7}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 3}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.23606797749979}}, "df": 5}, "1": {"0": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "1": {"6": {"2": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"1": {"5": {"0": {"7": {"7": {"1": {"9": {"0": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "5": {"2": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"0": {"6": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "8": {"4": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"9": {"6": {"2": {"4": {"3": {"8": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"0": {"8": {"3": {"8": {"6": {"2": {"5": {"8": {"3": {"8": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"6": {"9": {"0": {"7": {"3": {"3": {"4": {"0": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "2": {"5": {"3": {"3": {"3": {"6": {"6": {"3": {"6": {"1": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "4": {"9": {"5": {"7": {"3": {"6": {"2": {"0": {"7": {"0": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "5": {"4": {"7": {"1": {"2": {"8": {"3": {"2": {"0": {"6": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"6": {"1": {"0": {"7": {"3": {"2": {"0": {"6": {"3": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"0": {"8": {"2": {"9": {"9": {"1": {"4": {"7": {"9": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"7": {"5": {"1": {"0": {"9": {"8": {"3": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"0": {"4": {"1": {"5": {"7": {"5": {"4": {"9": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"5": {"4": {"3": {"7": {"0": {"4": {"3": {"3": {"6": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "6": {"9": {"6": {"1": {"4": {"3": {"0": {"5": {"1": {"6": {"2": {"6": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"1": {"6": {"7": {"1": {"3": {"7": {"1": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"0": {"8": {"4": {"7": {"4": {"1": {"2": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"6": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"7": {"2": {"4": {"5": {"6": {"0": {"3": {"5": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"0": {"4": {"8": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "5": {"2": {"6": {"5": {"1": {"6": {"6": {"5": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "6": {"6": {"6": {"8": {"8": {"2": {"2": {"7": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"6": {"5": {"3": {"0": {"0": {"3": {"2": {"2": {"4": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"9": {"6": {"5": {"7": {"0": {"3": {"7": {"1": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"0": {"3": {"1": {"6": {"7": {"4": {"4": {"7": {"4": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"0": {"7": {"7": {"6": {"2": {"7": {"0": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "5": {"0": {"5": {"4": {"7": {"0": {"4": {"5": {"5": {"8": {"6": {"5": {"1": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"3": {"5": {"9": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"5": {"5": {"4": {"3": {"9": {"4": {"1": {"3": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"4": {"5": {"9": {"6": {"7": {"3": {"2": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"1": {"3": {"8": {"0": {"0": {"7": {"1": {"1": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"3": {"5": {"2": {"2": {"9": {"7": {"5": {"7": {"0": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "5": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "6": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "9": {"2": {"9": {"9": {"7": {"8": {"1": {"1": {"8": {"1": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"8": {"8": {"2": {"7": {"4": {"1": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"0": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "8": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"7": {"0": {"1": {"1": {"6": {"7": {"5": {"6": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"3": {"4": {"4": {"9": {"0": {"5": {"9": {"1": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"6": {"8": {"4": {"1": {"1": {"0": {"5": {"3": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"1": {"0": {"9": {"4": {"6": {"3": {"9": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "6": {"3": {"7": {"8": {"1": {"7": {"6": {"7": {"8": {"5": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"7": {"4": {"1": {"6": {"6": {"6": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"5": {"9": {"1": {"2": {"2": {"4": {"7": {"3": {"7": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"0": {"2": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"7": {"5": {"0": {"5": {"6": {"9": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"7": {"0": {"9": {"5": {"7": {"2": {"9": {"4": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "5": {"1": {"1": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"1": {"0": {"2": {"0": {"4": {"0": {"8": {"1": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"4": {"9": {"6": {"6": {"5": {"7": {"4": {"0": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"4": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"0": {"9": {"5": {"8": {"2": {"1": {"5": {"9": {"2": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"6": {"9": {"8": {"0": {"3": {"0": {"6": {"3": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 10.246950765959598}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 6, "n": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}}}, "6": {"3": {"1": {"6": {"3": {"9": {"3": {"3": {"6": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 2}, "7": {"0": {"4": {"4": {"2": {"1": {"4": {"3": {"1": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"4": {"6": {"1": {"7": {"0": {"6": {"7": {"8": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"3": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"1": {"6": {"2": {"2": {"0": {"0": {"5": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"5": {"6": {"0": {"7": {"1": {"0": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"3": {"5": {"9": {"3": {"2": {"2": {"1": {"1": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "4": {"7": {"8": {"1": {"4": {"8": {"6": {"2": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 11}, "5": {"docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1}}, "df": 2}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"1": {"5": {"2": {"5": {"3": {"0": {"6": {"3": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.NEON_WL": {"tf": 2.6457513110645907}}, "df": 10}, "8": {"0": {"0": {"0": {"0": {"docs": {}, "df": 0, "x": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}, "docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "x": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.8284271247461903}}, "df": 1}, "docs": {}, "df": 0}}}}, "1": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"5": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"3": {"3": {"3": {"5": {"0": {"0": {"8": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.23606797749979}}, "df": 5, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1, "x": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}, "2": {"7": {"2": {"1": {"0": {"8": {"8": {"4": {"2": {"9": {"4": {"8": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "3": {"0": {"6": {"3": {"4": {"5": {"7": {"3": {"3": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"1": {"4": {"8": {"9": {"5": {"4": {"2": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"2": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"3": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"2": {"2": {"0": {"2": {"1": {"0": {"6": {"6": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "9": {"4": {"2": {"8": {"8": {"2": {"0": {"2": {"9": {"5": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4.47213595499958}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 4.69041575982343}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2.23606797749979}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.23606797749979}}, "df": 6}, "1": {"0": {"1": {"6": {"7": {"0": {"6": {"3": {"3": {"1": {"2": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "2": {"7": {"1": {"8": {"4": {"9": {"6": {"6": {"8": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "3": {"0": {"5": {"5": {"8": {"6": {"4": {"5": {"2": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "6": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"0": {"1": {"9": {"1": {"2": {"5": {"9": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}}, "df": 1}, "7": {"3": {"1": {"9": {"2": {"6": {"7": {"1": {"3": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"5": {"9": {"4": {"1": {"0": {"4": {"3": {"0": {"7": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"6": {"9": {"0": {"6": {"6": {"4": {"9": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "5": {"7": {"7": {"4": {"8": {"1": {"9": {"5": {"8": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"0": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"1": {"0": {"3": {"1": {"8": {"7": {"1": {"2": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "5": {"3": {"5": {"4": {"7": {"9": {"4": {"0": {"2": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2.449489742783178}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.449489742783178}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "7": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "6": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"9": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"0": {"1": {"4": {"1": {"7": {"4": {"5": {"3": {"6": {"1": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"8": {"9": {"0": {"2": {"9": {"0": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "3": {"5": {"3": {"0": {"5": {"5": {"0": {"0": {"8": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"4": {"6": {"7": {"1": {"2": {"0": {"0": {"4": {"0": {"2": {"3": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"5": {"8": {"9": {"9": {"6": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"6": {"1": {"8": {"1": {"2": {"3": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "7": {"0": {"8": {"5": {"9": {"7": {"5": {"2": {"1": {"2": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"7": {"2": {"6": {"0": {"9": {"6": {"5": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 2}}, "df": 8}, "8": {"7": {"5": {"0": {"3": {"9": {"4": {"4": {"4": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"9": {"0": {"4": {"2": {"8": {"5": {"0": {"3": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"1": {"2": {"6": {"9": {"8": {"4": {"1": {"2": {"1": {"4": {"0": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "2": {"7": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"9": {"8": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "7": {"2": {"1": {"1": {"3": {"6": {"0": {"8": {"2": {"6": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "9": {"4": {"7": {"9": {"3": {"3": {"1": {"0": {"1": {"9": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "docs": {}, "df": 0}, "5": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"4": {"0": {"1": {"3": {"6": {"0": {"5": {"4": {"3": {"1": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"9": {"8": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"5": {"9": {"3": {"7": {"7": {"1": {"6": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"2": {"1": {"2": {"6": {"8": {"5": {"3": {"7": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"4": {"3": {"7": {"9": {"9": {"3": {"0": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "5": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "5": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"7": {"6": {"2": {"3": {"3": {"0": {"1": {"8": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "8": {"5": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "docs": {}, "df": 0}, "6": {"0": {"9": {"9": {"8": {"2": {"6": {"6": {"8": {"5": {"9": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "2": {"1": {"4": {"4": {"4": {"2": {"0": {"1": {"3": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"0": {"6": {"3": {"8": {"6": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"1": {"0": {"3": {"8": {"1": {"5": {"9": {"4": {"8": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"4": {"5": {"5": {"7": {"8": {"2": {"3": {"1": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"4": {"9": {"5": {"1": {"0": {"8": {"8": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "4": {"3": {"5": {"0": {"0": {"3": {"7": {"6": {"1": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "5": {"6": {"4": {"2": {"5": {"6": {"4": {"2": {"8": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "6": {"1": {"6": {"5": {"1": {"9": {"3": {"3": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"5": {"4": {"1": {"9": {"0": {"9": {"1": {"8": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "7": {"1": {"6": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "3": {"6": {"7": {"0": {"4": {"1": {"2": {"8": {"8": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "8": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"6": {"5": {"8": {"5": {"7": {"1": {"2": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.NEON_WL": {"tf": 2}}, "df": 6}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1, "m": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}}}, "7": {"0": {"9": {"3": {"7": {"2": {"0": {"4": {"1": {"6": {"5": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "1": {"1": {"5": {"6": {"1": {"8": {"8": {"8": {"6": {"3": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"3": {"4": {"9": {"6": {"2": {"9": {"2": {"4": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"0": {"7": {"0": {"7": {"1": {"1": {"3": {"8": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"2": {"3": {"0": {"5": {"2": {"2": {"0": {"2": {"2": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"2": {"7": {"3": {"5": {"2": {"2": {"9": {"7": {"5": {"7": {"1": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"7": {"0": {"8": {"7": {"7": {"3": {"4": {"4": {"7": {"2": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"4": {"6": {"1": {"7": {"0": {"6": {"7": {"8": {"0": {"5": {"1": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 8}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 2}}, "df": 8}, "9": {"4": {"5": {"7": {"2": {"4": {"2": {"0": {"3": {"2": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"6": {"6": {"3": {"8": {"9": {"2": {"2": {"0": {"2": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"3": {"5": {"3": {"5": {"2": {"3": {"2": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"7": {"0": {"2": {"0": {"6": {"8": {"4": {"2": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 6}, "4": {"2": {"7": {"7": {"9": {"0": {"5": {"4": {"5": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"9": {"2": {"2": {"0": {"9": {"6": {"0": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "6": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "7": {"1": {"1": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "1": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "3": {"9": {"7": {"9": {"2": {"4": {"6": {"6": {"4": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "2": {"5": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"3": {"4": {"1": {"7": {"4": {"7": {"5": {"7": {"5": {"2": {"2": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"4": {"0": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"7": {"8": {"9": {"5": {"5": {"2": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "9": {"6": {"7": {"1": {"7": {"7": {"2": {"4": {"2": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"1": {"5": {"5": {"3": {"6": {"1": {"0": {"5": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"6": {"8": {"0": {"0": {"8": {"3": {"6": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 2.449489742783178}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 2.449489742783178}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 2.6457513110645907}}, "df": 12}, "9": {"0": {"0": {"0": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}}}, "1": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "2": {"2": {"6": {"7": {"5": {"7": {"3": {"6": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "5": {"6": {"5": {"0": {"6": {"8": {"1": {"3": {"3": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"8": {"0": {"3": {"8": {"8": {"7": {"7": {"7": {"8": {"8": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"3": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"8": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "8": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "9": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 3.3166247903554}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 5}, "1": {"0": {"2": {"8": {"4": {"4": {"6": {"3": {"8": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"3": {"0": {"0": {"8": {"2": {"3": {"6": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "9": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "1": {"5": {"6": {"4": {"6": {"2": {"5": {"4": {"5": {"3": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "3": {"0": {"3": {"1": {"0": {"8": {"4": {"1": {"5": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"6": {"6": {"0": {"8": {"3": {"1": {"5": {"0": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "5": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"3": {"1": {"9": {"3": {"4": {"8": {"3": {"9": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"0": {"0": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"5": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "1": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "2": {"4": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 5}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "3": {"4": {"1": {"8": {"3": {"8": {"2": {"8": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 3}, "4": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"0": {"4": {"2": {"4": {"1": {"2": {"4": {"8": {"8": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"9": {"2": {"7": {"9": {"3": {"5": {"5": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"2": {"4": {"8": {"4": {"5": {"4": {"6": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"3": {"9": {"3": {"9": {"1": {"9": {"8": {"8": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"3": {"7": {"6": {"4": {"1": {"7": {"2": {"3": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"5": {"9": {"8": {"2": {"0": {"9": {"3": {"6": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"4": {"1": {"8": {"6": {"7": {"3": {"1": {"8": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "8": {"9": {"9": {"9": {"6": {"8": {"4": {"4": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "9": {"7": {"0": {"5": {"2": {"1": {"5": {"4": {"1": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"4": {"3": {"3": {"3": {"9": {"3": {"1": {"9": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"0": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "1": {"9": {"7": {"2": {"7": {"8": {"9": {"8": {"5": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 5}, "2": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "5": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"2": {"1": {"6": {"8": {"0": {"3": {"8": {"8": {"9": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "8": {"7": {"3": {"0": {"8": {"5": {"3": {"3": {"3": {"3": {"8": {"3": {"4": {"3": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "4": {"0": {"8": {"0": {"6": {"0": {"5": {"4": {"9": {"3": {"3": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "3": {"1": {"0": {"7": {"2": {"2": {"1": {"0": {"0": {"6": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"2": {"9": {"5": {"4": {"0": {"4": {"8": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "6": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "6": {"7": {"0": {"8": {"7": {"2": {"9": {"3": {"9": {"4": {"5": {"5": {"1": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"6": {"8": {"6": {"3": {"7": {"7": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"3": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"1": {"1": {"7": {"6": {"9": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "9": {"5": {"4": {"6": {"5": {"9": {"5": {"4": {"1": {"2": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"3": {"0": {"8": {"3": {"9": {"8": {"2": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "9": {"2": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "6": {"9": {"8": {"4": {"3": {"6": {"2": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"0": {"5": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "docs": {}, "df": 0}, "1": {"7": {"1": {"9": {"7": {"8": {"5": {"4": {"2": {"1": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"3": {"0": {"8": {"6": {"2": {"1": {"7": {"0": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"7": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"3": {"5": {"2": {"3": {"4": {"7": {"0": {"1": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "3": {"7": {"6": {"0": {"3": {"0": {"1": {"4": {"4": {"5": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 8}, "4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "5": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "8": {"6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "9": {"1": {"8": {"3": {"6": {"7": {"3": {"4": {"6": {"9": {"4": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"1": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"3": {"1": {"7": {"8": {"6": {"4": {"7": {"1": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"7": {"1": {"8": {"8": {"2": {"0": {"8": {"6": {"1": {"7": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"2": {"7": {"5": {"4": {"5": {"4": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 7}, "7": {"8": {"1": {"3": {"1": {"9": {"0": {"2": {"8": {"0": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "8": {"3": {"4": {"1": {"0": {"6": {"1": {"4": {"3": {"7": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "7": {"0": {"4": {"2": {"7": {"1": {"1": {"6": {"2": {"8": {"6": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"9": {"6": {"1": {"6": {"2": {"5": {"8": {"5": {"4": {"2": {"5": {"2": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"2": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"8": {"7": {"8": {"5": {"6": {"8": {"3": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "4": {"5": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "8": {"7": {"6": {"8": {"7": {"4": {"5": {"7": {"8": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "7": {"3": {"2": {"4": {"2": {"6": {"3": {"0": {"3": {"8": {"6": {"docs": {"ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"0": {"7": {"6": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"3": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"9": {"8": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 5}, "2": {"4": {"9": {"4": {"5": {"2": {"9": {"5": {"4": {"0": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"6": {"0": {"3": {"1": {"8": {"8": {"2": {"5": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"7": {"6": {"4": {"9": {"0": {"9": {"5": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "3": {"3": {"4": {"0": {"2": {"8": {"3": {"9": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"4": {"3": {"3": {"0": {"9": {"7": {"7": {"5": {"5": {"docs": {"ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"4": {"1": {"4": {"2": {"3": {"7": {"2": {"6": {"6": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"4": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"1": {"1": {"9": {"3": {"0": {"9": {"5": {"6": {"7": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"7": {"0": {"1": {"8": {"2": {"3": {"8": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"6": {"0": {"4": {"0": {"2": {"5": {"7": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"1": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"3": {"7": {"1": {"4": {"0": {"2": {"3": {"5": {"2": {"2": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"0": {"7": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "4": {"0": {"4": {"1": {"6": {"6": {"0": {"9": {"5": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "3": {"7": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"0": {"2": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"9": {"2": {"3": {"2": {"4": {"3": {"4": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"1": {"9": {"1": {"9": {"1": {"9": {"6": {"1": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "9": {"2": {"4": {"5": {"2": {"8": {"4": {"9": {"5": {"7": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"1": {"8": {"2": {"9": {"8": {"1": {"8": {"0": {"6": {"docs": {"ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "6": {"8": {"docs": {"ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1}}, "df": 2}, "9": {"docs": {"ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.4142135623730951}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.constants.PST_RS_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.4142135623730951}}, "df": 10}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 36.98648401781386}, "ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 2.23606797749979}, "ramanchada2.io.HSDS.logger": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1.4142135623730951}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 14.352700094407323}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 14.352700094407323}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 14.38749456993816}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 14.38749456993816}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 6.164414002968976}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 6.164414002968976}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 7.745966692414834}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 7.416198487095663}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1.4142135623730951}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 2.8284271247461903}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 2.449489742783178}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 2.6457513110645907}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 3.7416573867739413}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 3.1622776601683795}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 56, "x": {"1": {"0": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "7": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 65.60487786742691}, "ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1.4142135623730951}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1.4142135623730951}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 3.4641016151377544}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.8284271247461903}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 9.16515138991168}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 4.47213595499958}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 2.8284271247461903}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 2.8284271247461903}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 4}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 4.898979485566356}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 3.7416573867739413}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 3.7416573867739413}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 4.242640687119285}}, "df": 24}, "docs": {}, "df": 0}, "5": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}}, "df": 1, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.7320508075688772}}, "df": 3, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}}, "df": 1}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.7320508075688772}}, "df": 1}}}}}, "o": {"docs": {}, "df": 0, "p": {"0": {"1": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3}}, "df": 1}, "2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3}}, "df": 1}, "3": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 12.083045973594572}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}}, "df": 2, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 1}}}}}}, "r": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}}, "df": 2}}, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 12.083045973594572}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1.4142135623730951}}, "df": 3}}}}, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 3, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}}}}}, "c": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}}, "df": 1}}, "f": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 3.3166247903554}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 2}}, "df": 7}}}}}, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}}, "df": 1}}}}}}}}}}, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1.7320508075688772}}, "df": 1, "a": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}}, "df": 1}, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1, "n": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}}, "df": 1, "[": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1}}}}}}}, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1}}}}}, "b": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 7.211102550927978}}, "df": 1, "w": {"5": {"3": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1, "/": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2}}, "df": 1, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "q": {"0": {"4": {"3": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"5": {"3": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"2": {"2": {"4": {"2": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}}}}, "p": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}, "s": {"0": {"docs": {}, "df": 0, "b": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "n": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "p": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "1": {"docs": {}, "df": 0, "n": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"5": {"3": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}}}}}}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1, "/": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}, "s": {"0": {"docs": {}, "df": 0, "b": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "n": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "p": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "1": {"docs": {}, "df": 0, "n": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"0": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}, "i": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1, "s": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"2": {"2": {"4": {"1": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}}}, "e": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}, "t": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "/": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 7.0710678118654755}}, "df": 1}, "docs": {}, "df": 0}}}}}}}}}}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 10.392304845413264}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 3.1622776601683795}}, "df": 2}}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1.4142135623730951}}, "df": 1, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.7320508075688772}}, "df": 1}}}}}}}, "y": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}}, "df": 1}}}}}}}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 2, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 12.083045973594572}}, "df": 1}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 2.6457513110645907}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}}, "df": 2}}}}, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 1}, "d": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}, "t": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}}, "df": 2, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}}, "df": 1}}}}, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 2.8284271247461903}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 3.4641016151377544}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 2.23606797749979}}, "df": 8}}}}}}}}, "m": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 6.4031242374328485}}, "df": 1}}}, "n": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 9.643650760992955}}, "df": 1}}}, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}, "n": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}}, "df": 2}}}}}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}}, "df": 1}}}}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"6": {"4": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 20.09975124224178}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 20.09975124224178}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 20.09975124224178}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 20.09975124224178}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 8.602325267042627}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 8.602325267042627}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 10.862780491200215}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 10.392304845413264}}, "df": 8}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.7320508075688772}}, "df": 5}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}}, "df": 4}}}, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 3.3166247903554}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 2}}, "df": 7}}}}}, "m": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 6.4031242374328485}}, "df": 1, "w": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 7.0710678118654755}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 2}, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 7.0710678118654755}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 3}, "o": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 2.449489742783178}}, "df": 1}}}}, "f": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 2}}}}, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 1}}}}, "u": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1, "t": {"docs": {}, "df": 0, "i": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 2}}, "df": 2, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "s": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}}, "df": 1}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 1}}}}, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.4142135623730951}}, "df": 2}}}}}}}, "a": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 2}}, "df": 2}}}, "i": {"docs": {}, "df": 0, "r": {"5": {"3": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.1622776601683795}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 5.196152422706632}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"5": {"3": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.7416573867739413}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4.69041575982343}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"7": {"8": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 7.0710678118654755}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}}, "c": {"docs": {}, "df": 0, "v": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 11.832159566199232}}, "df": 1}}, "o": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}}, "df": 1}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 2, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}}, "df": 1}}}}}}}, "f": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 2.8284271247461903}}, "df": 2}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 1}}}}}}}, "d": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 2}}, "p": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 7.0710678118654755}}, "df": 1, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 6.082762530298219}}, "df": 1}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 12.083045973594572}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 2}}}}}, "c": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}}, "df": 1}, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}}, "df": 2}}}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.1622776601683795}}, "df": 1}, "e": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 2}}}}}}}}}}, "o": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 10}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1.4142135623730951}}, "df": 2}}}, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}}, "df": 2}}}}}, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 2}}}}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 7.0710678118654755}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 2}}}}}, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1.4142135623730951}}, "df": 4}}, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"4": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 2}, "7": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}}}}}}, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"2": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}}}}}}, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}}, "df": 1, "/": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}}}}}}}}, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}, "docs": {}, "df": 0}}}}}}}}}}}}}}}}}, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}}, "df": 1}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}}, "df": 1}, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 2.8284271247461903}}, "df": 1}}}}}}}}}, "d": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 1}}}, "b": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1.4142135623730951}}, "df": 1}}}, "t": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 12.083045973594572}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}}, "df": 2}}, "o": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 1, "p": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 4.242640687119285}}, "df": 1}, "x": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"3": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1.7320508075688772}}, "df": 3}, "docs": {}, "df": 0}}}}}}}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "o": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 7.0710678118654755}}, "df": 1}, "docs": {}, "df": 0}, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 7.0710678118654755}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 3}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}, "u": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 2.8284271247461903}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 12, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}}}, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}}, "df": 1}}}}}}}}}}, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}}}}}}}}}, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}}, "df": 4}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 3}}}}}, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}}, "df": 1}}}}}}}}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 15.684387141358123}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1.7320508075688772}}, "df": 2}}}, "m": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}}, "df": 2}}}}}, "e": {"docs": {}, "df": 0, "d": {"5": {"3": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}}}, "t": {"docs": {"ramanchada2.io.HSDS.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.8284271247461903}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1}}, "df": 11}, "o": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1}}, "df": 8}}}}, "w": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}}, "df": 2}}}}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1.4142135623730951}}, "df": 3}, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 1}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}}, "df": 1, "[": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}}, "df": 1}}}}}}}}}, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1}}}}}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 2}}}}}}}, "w": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 12.083045973594572}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 2}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.io.HSDS.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1}}, "df": 9}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}}, "df": 1}}}}}}}}}}, "s": {"0": {"docs": {}, "df": 0, "b": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.3166247903554}}, "df": 1}, "n": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.1622776601683795}}, "df": 1}, "p": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.1622776601683795}}, "df": 1}}, "1": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.1622776601683795}}, "df": 1}}, "docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 12.083045973594572}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 2}}}}}, "i": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.23606797749979}}, "df": 1}, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 4}}}, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}}}}}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.1622776601683795}}, "df": 1, "e": {"2": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}}, "df": 1}, "3": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}}, "df": 2}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1}}}}}}}}}, "r": {"docs": {}, "df": 0, "m": {"2": {"2": {"4": {"1": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "2": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}, "u": {"docs": {}, "df": 0, "b": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 2}}, "df": 1}}}}}}}, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.7320508075688772}}, "df": 1}}}}}}}}, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}}, "df": 3}}}}, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.7320508075688772}}, "df": 1}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1.4142135623730951}}, "df": 6}}}}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}}}}}, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 3, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}}, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 2.449489742783178}}, "df": 1}}}}}, "k": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}}, "df": 1}}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}}, "df": 1}}}}}, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.4641016151377544}}, "df": 1}}, "w": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.1622776601683795}}, "df": 1}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"5": {"3": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "r": {"7": {"8": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 3.4641016151377544}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}}, "df": 3}, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 2}}}, "p": {"docs": {"ramanchada2.misc.constants.neon_rs_dict": {"tf": 20.09975124224178}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 20.09975124224178}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 20.09975124224178}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 20.09975124224178}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 8.602325267042627}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 8.602325267042627}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 10.862780491200215}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 10.392304845413264}}, "df": 8}, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}}, "df": 2}}}}, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.7320508075688772}}, "df": 1}}}, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}}}}, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 3.3166247903554}}, "df": 1, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 3.3166247903554}}, "df": 3}}}}}}}, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1}}}}, "m": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 1}, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}, "e": {"docs": {}, "df": 0, "l": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2}}, "df": 1}, "docs": {}, "df": 0}, "x": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}}, "df": 1}}}}}}}}}, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}}}}}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}}, "df": 1}}}}}}}}, "h": {"docs": {}, "df": 0, "o": {"6": {"3": {"3": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}}, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}, "s": {"0": {"docs": {}, "df": 0, "b": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "n": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "p": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}, "1": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}, "docs": {}, "df": 0, "i": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}}}}}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"5": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "q": {"0": {"4": {"3": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"7": {"8": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}, "p": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}, "s": {"0": {"docs": {}, "df": 0, "b": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "n": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "p": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "1": {"docs": {}, "df": 0, "n": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"7": {"8": {"5": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 6.164414002968976}}, "df": 1}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"2": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"2": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1.7320508075688772}}, "df": 3}, "docs": {}, "df": 0}}}}}}}}}}}}, "docs": {}, "df": 0}}}}}}}}}}}}}}}}}}}}}}}}}}, "l": {"docs": {}, "df": 0, "r": {"6": {"3": {"3": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.8284271247461903}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 1}}, "d": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}}, "z": {"0": {"1": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3}}, "df": 1}, "docs": {}, "df": 0}, "2": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 2.8284271247461903}}, "df": 1}, "docs": {}, "df": 0}, "5": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.7416573867739413}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"0": {"0": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 3.7416573867739413}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 7.0710678118654755}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 3}}}}}}}, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}}, "df": 1}}}}}, "s": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 1}}}}}}, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 2.8284271247461903}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 3.4641016151377544}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 2.23606797749979}}, "df": 8}}}}}}}, "o": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}}, "df": 1}}, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.HSDS.logger": {"tf": 1}}, "df": 1, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.HSDS.logger": {"tf": 1}}, "df": 1}}}}}}}}}, "a": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1.4142135623730951}}, "df": 1}, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}}, "df": 2, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"2": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1}}, "df": 8}, "docs": {}, "df": 0}}}}}}}}}, "c": {"1": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.7320508075688772}}, "df": 2}, "docs": {}, "df": 0}, "b": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}, "c": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}}, "df": 1, "o": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1}}, "df": 1}}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}}}}}}}, "n": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 3, "d": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}}, "df": 1}}}, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}}, "df": 1}}}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}}, "df": 2}}}}}}}}, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}}, "df": 2, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1.7320508075688772}}, "df": 1}}}}, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}}, "df": 2}}}}}}}}}, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}}, "df": 2}}}}, "r": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 2}}, "df": 1}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}}, "df": 1}}}}}}}, "m": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 1}, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}, "d": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1}}, "df": 1}}}}}, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1.4142135623730951}}, "df": 1}}}, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.4142135623730951}}, "df": 3}}}}}, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1}}, "df": 1, "o": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}}, "df": 4}}}}}, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}, "d": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 2.23606797749979}}, "df": 1}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 1}}}}}}, "x": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}, "r": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"2": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}, "docs": {}, "df": 0}}}, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}}, "df": 1}}, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}}, "df": 4}}}}}}}}, "b": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}}, "df": 1}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}}, "df": 1}}}}}}}}, "n": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 2.8284271247461903}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 3.4641016151377544}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 2.23606797749979}}, "df": 8}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 2}}}, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1}}}}}}}}}}}, "y": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1.7320508075688772}}, "df": 1}}}, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.HSDS.logger": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 2.8284271247461903}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2.8284271247461903}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 2}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 2}}, "df": 14}, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.constants.neon_rs_spe": {"tf": 2}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 2}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 6}}}}}}}, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1}}, "df": 2}}}, "y": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1}}, "df": 1}}}}}, "k": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}}, "df": 1}}}}}}, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1}}, "df": 1}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 2.449489742783178}}, "df": 2}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 1}}}}}}}}, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}}, "f": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1.7320508075688772}}, "df": 1}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}}, "df": 1}}}}}}}}, "r": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}}, "df": 1}}}}}, "signature": {"root": {"0": {"0": {"1": {"docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "1": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 2}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 2.23606797749979}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 2}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.7320508075688772}}, "df": 66}, "1": {"0": {"0": {"0": {"0": {"0": {"docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 17}, "docs": {"ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}}, "df": 12}, "4": {"4": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"0": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 39}, "2": {"0": {"0": {"0": {"docs": {"ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 8}, "docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 7}, "3": {"0": {"0": {"0": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}}, "df": 3}, "9": {"docs": {"ramanchada2.io.HSDS.visit_domain": {"tf": 1.4142135623730951}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 5.291502622129181}, "ramanchada2.misc.plottable.Plottable.plot": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 4.898979485566356}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 4.69041575982343}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 4.242640687119285}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 5.477225575051661}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 4}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 4.242640687119285}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 3.7416573867739413}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 2}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 2}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 4}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 4}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 6}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 6.782329983125268}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 6}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 7.483314773547883}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 3.7416573867739413}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 6.782329983125268}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 4}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 2}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 3.4641016151377544}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 5.656854249492381}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 5.291502622129181}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 4}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 4}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 6}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 6.782329983125268}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 6}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 7.483314773547883}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 3.7416573867739413}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 6.782329983125268}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 4}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 3.4641016151377544}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 5.291502622129181}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 2.449489742783178}}, "df": 68}, "docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}}, "df": 3}, "4": {"0": {"0": {"0": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 8}, "docs": {}, "df": 0}, "docs": {"ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 2}, "5": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}}, "df": 2}, "5": {"0": {"0": {"0": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 5}, "1": {"4": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "2": {"0": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "3": {"2": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}}, "df": 4}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 3}, "6": {"3": {"3": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {"ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 2}, "7": {"8": {"5": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}}, "df": 6}, "docs": {}, "df": 0}, "docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}}, "df": 3}, "8": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}}, "df": 1}, "9": {"docs": {"ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"tf": 3.4641016151377544}, "ramanchada2.auxiliary.spectra.datasets2.get_filters": {"tf": 3.4641016151377544}, "ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"tf": 3.4641016151377544}, "ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"tf": 3.1622776601683795}, "ramanchada2.io.HSDS.write_nexus": {"tf": 10.770329614269007}, "ramanchada2.io.HSDS.sanitize_key": {"tf": 4}, "ramanchada2.io.HSDS.write_cha": {"tf": 10.770329614269007}, "ramanchada2.io.HSDS.read_cha": {"tf": 9.695359714832659}, "ramanchada2.io.HSDS.filter_dataset": {"tf": 9.219544457292887}, "ramanchada2.io.HSDS.visit_domain": {"tf": 6.48074069840786}, "ramanchada2.io.experimental.bw_format.bw_format": {"tf": 6.557438524302}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 6.557438524302}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 4.69041575982343}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 3.1622776601683795}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 4.69041575982343}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 3.1622776601683795}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 3.1622776601683795}, "ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 4.242640687119285}, "ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"tf": 3.1622776601683795}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 3.1622776601683795}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 3.1622776601683795}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 4.242640687119285}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 4.242640687119285}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 5.830951894845301}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 3.1622776601683795}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 3.1622776601683795}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 3.1622776601683795}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 3.1622776601683795}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 8.426149773176359}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 3.1622776601683795}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 8.426149773176359}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 9}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 5.5677643628300215}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 5.656854249492381}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 5.656854249492381}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 5.656854249492381}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 13.30413469565007}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 5.656854249492381}, "ramanchada2.misc.plottable.Plottable.plot": {"tf": 7}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 3.4641016151377544}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 3.1622776601683795}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 4.242640687119285}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 3.7416573867739413}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 4.795831523312719}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 5.830951894845301}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 3.7416573867739413}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 4.242640687119285}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 5.656854249492381}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 6.708203932499369}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 4.69041575982343}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 3.7416573867739413}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 3.7416573867739413}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 4.123105625617661}, "ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 5.385164807134504}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 4.47213595499958}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 4.47213595499958}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 12.12435565298214}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 8.717797887081348}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 7.937253933193772}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 7.874007874011811}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 7.874007874011811}, "ramanchada2.misc.utils.matchsets.normalize_tuples": {"tf": 3.1622776601683795}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 7.874007874011811}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 8.426149773176359}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 3.7416573867739413}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 3.7416573867739413}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 3.7416573867739413}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 3.7416573867739413}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 3.7416573867739413}, "ramanchada2.misc.utils.svd.svd_solve": {"tf": 3.7416573867739413}, "ramanchada2.misc.utils.svd.svd_inverse": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 7.483314773547883}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 8.717797887081348}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 9.848857801796104}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 5.656854249492381}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 5.477225575051661}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 6.48074069840786}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 7.211102550927978}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 6.48074069840786}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 7}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 3.4641016151377544}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 15.905973720586866}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 13.711309200802088}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 10.954451150103322}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 6.557438524302}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 7}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 13.92838827718412}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 14.38749456993816}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 8.48528137423857}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 6.48074069840786}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 5.0990195135927845}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 4.69041575982343}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 11.090536506409418}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 6.48074069840786}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 5.0990195135927845}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 8.48528137423857}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 4}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 3.4641016151377544}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 4}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 4.898979485566356}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 4.242640687119285}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 5.291502622129181}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 4.898979485566356}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 6.244997998398398}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 6.48074069840786}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 4.242640687119285}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 4.242640687119285}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 4.242640687119285}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 7.211102550927978}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 4.69041575982343}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 2.8284271247461903}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 4.69041575982343}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 4.242640687119285}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 4.69041575982343}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 3.1622776601683795}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 4.69041575982343}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 6.928203230275509}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 6.928203230275509}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 7.615773105863909}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 6.4031242374328485}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 9.486832980505138}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 6}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 6}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 7}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 6.164414002968976}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 11}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 5.477225575051661}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 8.366600265340756}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 7.810249675906654}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 7.3484692283495345}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 3.1622776601683795}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 7}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 3.4641016151377544}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 3.1622776601683795}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 3.1622776601683795}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 3.7416573867739413}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 3.1622776601683795}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 3.1622776601683795}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 3.1622776601683795}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"tf": 3.1622776601683795}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 3.1622776601683795}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 11.180339887498949}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 10.770329614269007}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 11.135528725660043}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 6.855654600401044}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 9.16515138991168}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 7.54983443527075}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 7.54983443527075}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 7.54983443527075}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 9.643650760992955}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 6.164414002968976}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 5.830951894845301}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 13.45362404707371}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 9.695359714832659}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 11.874342087037917}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 14.45683229480096}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 10.392304845413264}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 6.48074069840786}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 6.48074069840786}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 7.937253933193772}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 7.937253933193772}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 10.954451150103322}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 9.16515138991168}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 10.63014581273465}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 7.937253933193772}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 9.539392014169456}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 7.416198487095663}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 6.164414002968976}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 11.832159566199232}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 13.30413469565007}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 16.673332000533065}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 6}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 14.832396974191326}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 4.47213595499958}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 16.61324772583615}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 9.746794344808963}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 11.445523142259598}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 12.96148139681572}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 8.831760866327848}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 13.856406460551018}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 9.746794344808963}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 9.591663046625438}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 9.591663046625438}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 9.591663046625438}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 6.928203230275509}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 9.591663046625438}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 9.591663046625438}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 9.591663046625438}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 7.54983443527075}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 7.3484692283495345}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 18.05547008526779}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 12.328828005937952}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 13.674794331177344}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 14.422205101855956}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 15.556349186104045}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 7.937253933193772}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 10}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 11.532562594670797}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 9.797958971132712}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 4.69041575982343}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 16.822603841260722}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 8.246211251235321}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 15.362291495737216}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 13.2664991614216}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 15.620499351813308}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 9.539392014169456}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 9.433981132056603}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 14.071247279470288}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 6.164414002968976}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 4.242640687119285}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 4.242640687119285}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"tf": 4.898979485566356}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 7.0710678118654755}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 6.324555320336759}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 6.855654600401044}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 6.855654600401044}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 6.082762530298219}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 7}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 7.54983443527075}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 7.54983443527075}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 9.16515138991168}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 7.54983443527075}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 10.770329614269007}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 9.643650760992955}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 7.937253933193772}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 10.954451150103322}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 6.48074069840786}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 6.48074069840786}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 7.937253933193772}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 7.937253933193772}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 13.45362404707371}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 9.695359714832659}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 11.874342087037917}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 14.45683229480096}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 10.392304845413264}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 9.539392014169456}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 9.16515138991168}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 10.63014581273465}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 7.416198487095663}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 6.164414002968976}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 11.832159566199232}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 13.30413469565007}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 16.673332000533065}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 6}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 14.832396974191326}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 4.47213595499958}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 16.61324772583615}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 9.591663046625438}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 9.591663046625438}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 9.746794344808963}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 8.831760866327848}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 13.856406460551018}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 15.556349186104045}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 7.937253933193772}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 10}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 9.746794344808963}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 9.591663046625438}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 9.591663046625438}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 9.591663046625438}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 9.591663046625438}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 7.54983443527075}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 9.797958971132712}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 12.96148139681572}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 18.05547008526779}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 12.328828005937952}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 13.674794331177344}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 14.422205101855956}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 7.3484692283495345}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 6.928203230275509}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 11.532562594670797}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 15.362291495737216}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 9.433981132056603}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 16.822603841260722}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 8.246211251235321}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 15.620499351813308}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 9.539392014169456}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 10.723805294763608}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 7.745966692414834}}, "df": 326, "k": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}}, "df": 25, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filters": {"tf": 1}, "ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"tf": 1}, "ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.io.HSDS.visit_domain": {"tf": 1}, "ramanchada2.misc.plottable.Plottable.plot": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.4142135623730951}}, "df": 42}}}}}, "e": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.io.HSDS.sanitize_key": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}}, "df": 4}, "r": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 2}}}}}, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}}}, "f": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1}}, "df": 3, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 14, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 19, "s": {"docs": {"ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"tf": 1}}, "df": 1}}}}}, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 3}}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 17}}, "t": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 24, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 2}}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 2}}}}}}}}}}}}, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}}, "df": 8}}, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 2}}}}}}, "e": {"docs": {}, "df": 0, "q": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3}}, "o": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 1}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}}, "df": 1}}, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"6": {"4": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 2}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 2}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 2}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 2}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 2}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 2}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1.4142135623730951}}, "df": 80}}}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}}}, "u": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 4, "c": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 5, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}}, "df": 1}}}}}}}, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 2}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 37}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}}, "df": 6}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.sanitize_key": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.write_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.read_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1.4142135623730951}}, "df": 30, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 4}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 2}}}}, "e": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 4, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 6}}}, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.write_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.read_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 20}}}}}}, "e": {"2": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}}, "df": 3}}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 6, "s": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}}}}}, "v": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 2}}}}}, "k": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}}, "df": 1}}, "e": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.4142135623730951}}, "df": 2}}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}}}}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}}, "df": 9}}}}}, "i": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}}, "df": 3, "m": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 3}, "g": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 2, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 15}}}, "l": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}}, "df": 3, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}}, "df": 1}}}}}, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}}, "df": 14}}, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}}, "df": 2}, "l": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.misc.plottable.Plottable.plot": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}}, "df": 104}}, "p": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}}, "df": 1}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 10}}}, "p": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4, "e": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.4142135623730951}}, "df": 127, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 2.449489742783178}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 2.449489742783178}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 2.449489742783178}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 2.449489742783178}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 2.449489742783178}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 2.449489742783178}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 2.449489742783178}}, "df": 135, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}}}}}}, "a": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}}, "df": 1, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 2}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1.4142135623730951}}, "df": 3}}}}}, "l": {"docs": {"ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1.4142135623730951}}, "df": 2, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}}}}}}}}}}}, "p": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}}, "df": 3}}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 3}}}}}}}}}}}}}}}}}}}, "s": {"docs": {"ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 2}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}}, "df": 11}}, "t": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}, "c": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}, "a": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}}, "df": 3}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 17}}}}, "a": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 2}}}}}}}}}, "r": {"docs": {}, "df": 0, "m": {"2": {"2": {"4": {"1": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}}, "df": 2}, "2": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}}, "df": 1}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}}, "df": 3}}}}}, "g": {"docs": {"ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 2}}, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3, "a": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 9, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.io.HSDS.visit_domain": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1}}, "df": 8}}}, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}}, "df": 8}}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.write_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.read_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 22}}}}, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 2}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}}, "df": 45}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}}, "df": 3}}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}}}}}}}, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}}, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.output.write_csv.write_csv": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1}}, "df": 2}}}}}}, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}}, "df": 9}}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 2}}}}, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 2}}}}}, "r": {"2": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 2}, "4": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}}, "f": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}}, "df": 5}, "x": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}, "h": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}, "p": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}, "x": {"2": {"7": {"docs": {"ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 28, "x": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "y": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "z": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1}}, "df": 1}}, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}}, "df": 4}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}}, "df": 2, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}}, "df": 1}}}}}}}}}}, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 8}}}}, "n": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}}, "df": 15, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 2}, "ramanchada2.io.HSDS.write_cha": {"tf": 2}, "ramanchada2.io.HSDS.read_cha": {"tf": 2}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 2}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 2}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 2}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 2}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.4142135623730951}}, "df": 22}}}, "t": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}}}, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.write_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.read_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 22}}}}}}, "o": {"docs": {"ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 6, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.io.HSDS.filter_dataset": {"tf": 2.449489742783178}, "ramanchada2.io.HSDS.visit_domain": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1}, "ramanchada2.misc.plottable.Plottable.plot": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 3.3166247903554}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2.23606797749979}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 3.3166247903554}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2.23606797749979}}, "df": 81, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 5}}}}}}, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}}, "df": 2}}}}}}}}, "m": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 24}, "e": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}}, "df": 2, "w": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 76, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}}, "df": 1}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1}}, "df": 1}}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}}, "df": 3}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 9, "s": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}}, "df": 1}}}, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"5": {"3": {"2": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "7": {"8": {"5": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}}, "df": 6}}}}, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "q": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 2}}}}}, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 4}}}}, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}}, "t": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.write_cha": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.7320508075688772}}, "df": 48}}}, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 4, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}}, "df": 11}}}}, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 24, "s": {"docs": {"ramanchada2.misc.utils.matchsets.normalize_tuples": {"tf": 1}}, "df": 1}}}}, "k": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}, "o": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 5, "p": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.io.HSDS.visit_domain": {"tf": 1}}, "df": 2}}}}}}, "o": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}}, "df": 2}}, "t": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.7320508075688772}}, "df": 3}}, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 14}}, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}, "m": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 4}}}, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}}, "df": 2, "b": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 9}}}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}}, "df": 2}}}}}}}, "h": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 6}}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.4142135623730951}}, "df": 2}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 1}}}}}}}}}}, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 2}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}}, "df": 7}}}}, "y": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}}, "w": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 1}}}}}}, "x": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4, "r": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}}}, "a": {"docs": {"ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.misc.utils.svd.svd_solve": {"tf": 1}}, "df": 4, "n": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.write_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.read_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 24}, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.7320508075688772}}, "df": 48}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}}, "x": {"docs": {"ramanchada2.misc.plottable.Plottable.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 10, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.plottable.Plottable.plot": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1.7320508075688772}}, "df": 4}}, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}}, "df": 2}}}, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 7}}}}}}, "r": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 20}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"2": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}}, "df": 4}}, "docs": {}, "df": 0}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 3}}}, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}}, "df": 4}}}}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 2}}}}}}}}, "k": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 4}}}}, "l": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.process": {"tf": 1}}, "df": 1}}}}}}}}}, "c": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.write_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.read_cha": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 20, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}}, "df": 8}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}}, "df": 3}}}}}, "l": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1.4142135623730951}}, "df": 1, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}}, "df": 2}}}, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 2}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 2}}}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 3}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}}, "df": 2}}}}, "n": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}}, "df": 4}}}, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}}, "df": 4}}}}}}}}}, "e": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3, "f": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}}, "df": 2}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 4}}}}}}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}}, "df": 2}}}, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}}, "df": 10}, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.4142135623730951}}, "df": 4}}}}}}, "r": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}}}}}}, "m": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}}, "df": 14}, "u": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 10}}}, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 10}}}}}}}}}, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 4}}}}}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 10}}}}}}, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 4}}}}}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}}, "df": 5}}}}}}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}}, "df": 1}}}}}}}}}, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 2}}}}}}, "s": {"docs": {}, "df": 0, "v": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}}, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 2}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 1}}, "df": 2}}}}}}, "w": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 2}}}, "y": {"0": {"docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}}, "df": 14, "y": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "z": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}}, "df": 1, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}}}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"tf": 1}}, "df": 3, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}}, "df": 4}}}}}, "h": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 8}}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 3}}}}}, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.svd.svd_inverse": {"tf": 1}}, "df": 1, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {"ramanchada2.misc.plottable.Plottable.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}}, "df": 4}}}}}}}, "c": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}}, "df": 4}}}, "x": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 7}, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}}, "df": 2}}}}}, "k": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 4}}}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}}, "df": 11}}, "n": {"docs": {"ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 4, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1.4142135623730951}}, "df": 2}}}, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}}}}}, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 4}}}}}}, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1.7320508075688772}}, "df": 4}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}}, "df": 2}}}}}, "f": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}}, "df": 7}}}}, "v": {"docs": {"ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 2, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 4}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}}}}}, "w": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 2}, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 2}, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.4142135623730951}}, "df": 2}}}}}}}}}}}}, "h": {"5": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.write_nexus": {"tf": 1}, "ramanchada2.io.HSDS.write_cha": {"tf": 1}, "ramanchada2.io.HSDS.read_cha": {"tf": 1}, "ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.io.HSDS.visit_domain": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1}}, "df": 7}}}}}}}, "docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}}, "df": 2}}}}, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}}, "df": 1}}}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}}, "df": 1}}}}}}}}, "m": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}}, "df": 2}}}}}, "n": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}}, "df": 2}}}, "p": {"0": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}}, "df": 2}, "1": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}}, "df": 2}, "docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}}, "df": 3, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}}, "df": 2, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.io.HSDS.visit_domain": {"tf": 1}}, "df": 2, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 6}}}}}}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 3}}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 6}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 5}}}}}}}, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}}, "df": 6}}}}}}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}}, "df": 2}}}}}}, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}}, "df": 2}}}}}}, "n": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}}, "df": 8}}}}, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1}}, "df": 3}}, "r": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}}, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 2}}}}}}}, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 2}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 2}}}}}, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 6, "s": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 20}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}}}, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"4": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}}, "df": 10}, "7": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}}, "df": 7}, "docs": {}, "df": 0}}}}}, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 2}}}}}}}, "o": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}}, "df": 2, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}}, "df": 1}}}}}}}, "w": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1.4142135623730951}}, "df": 2, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}}, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}}, "df": 2}}}, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}}, "df": 9}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.4142135623730951}}, "df": 2}}}}, "v": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 4}}}}}, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}}, "df": 3}}}}}}}}}}, "y": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 1}}}}}}}}}}}}, "w": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 13, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1}}, "df": 5}}}}}}}}}, "e": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}}, "df": 2}}}}}, "l": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 15, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 4}}}, "n": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}}, "df": 1}, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 6}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 18}}}}, "g": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 2}}}}}, "d": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}}, "i": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 4.358898943540674}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 4.358898943540674}}, "df": 3, "n": {"docs": {"ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 15, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}}, "df": 1}}}}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.io.HSDS.filter_dataset": {"tf": 1}}, "df": 1}}}}}}}}}, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.4142135623730951}}, "df": 2}}}}}, "t": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 2}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2.23606797749979}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2.23606797749979}}, "df": 50, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}}, "df": 2}, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}}, "df": 1}}}}}}}, "r": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 4, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}}, "df": 4}}}}}}}, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 5}}}}, "g": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}}, "df": 2}}}}}}, "f": {"docs": {"ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1.4142135623730951}}, "df": 2}, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}}, "df": 4}}, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}}, "df": 2}}}}, "o": {"docs": {"ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1.7320508075688772}}, "df": 9}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 4}}}}, "l": {"1": {"docs": {"ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1.4142135623730951}}, "df": 6, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 2}}}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 3}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1.4142135623730951}}, "df": 31, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 4}}}}}}}}}}}}}}}}}}}}}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}}, "df": 44}}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1}}, "df": 1}}}}, "e": {"docs": {"ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 5, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 14}}}}}, "t": {"docs": {"ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 8}, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.plottable.Plottable.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1}}, "df": 4}}}, "m": {"docs": {"ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}}, "df": 3, "b": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 22}}}}, "o": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 2, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 2}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}}, "df": 7}}}}}}}}, "g": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}}}}, "m": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1.4142135623730951}}, "df": 2}}}}}, "o": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "j": {"docs": {"ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1}}, "df": 1}}, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 3}}, "r": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}}, "df": 1, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}}, "df": 6}}}}, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2}}, "df": 23}}}}}}}, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 82}}, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1}}, "df": 2}}}}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 3}}, "l": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1}}, "df": 3, "u": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1}}, "df": 1}}}, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 2}}}, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1}}, "df": 8}}}}}, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 2}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 2}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 2}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 2}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}}, "df": 49}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 2, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 2}}}}}}}, "u": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1}}, "df": 4}}}}, "e": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2}}, "df": 9, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.7320508075688772}}, "df": 2}}}}}}, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 2, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"2": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}, "docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1.4142135623730951}}, "df": 16}}}}}}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 5}, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1}}, "df": 1, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"2": {"docs": {"ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1}}, "df": 131}, "docs": {}, "df": 0}}}}}}}}, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 13}}, "d": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}}}}}, "e": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1}}, "df": 14, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1.4142135623730951}}, "df": 5}}}}}}}, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1}}, "df": 3}}}}}}, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 2}}}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 3}}}}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}}}}, "b": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1}}, "df": 5}}, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 10}}, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}}, "c": {"1": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}, "docs": {}, "df": 0}}, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 3}}, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 24}}, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1.4142135623730951}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}}, "df": 12}, "y": {"docs": {"ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 2}}, "df": 2}}}}}, "z": {"docs": {}, "df": 0, "z": {"docs": {"ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1.4142135623730951}}, "df": 1}}}}, "j": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1}}, "df": 1}}}, "d": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}}, "b": {"docs": {"ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.misc.utils.svd.svd_solve": {"tf": 1}}, "df": 3, "u": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1}}, "df": 1, "f": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 2}}}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1}}, "df": 4, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 4}}}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}}, "df": 1}}, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}}}, "y": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 4, "g": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}}}}}}}}, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 3}}}}}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}}, "df": 2, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}}, "df": 8}}}}}, "s": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 2}}}}, "o": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.4142135623730951}}, "df": 12}}, "h": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}, "x": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 4}}}}}, "y": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 2, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1}}, "df": 2}}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 4}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 10}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 2}}}}}}}}}}}}}, "g": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}}, "df": 2}}}, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1}}, "df": 4}}}}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1}}, "df": 1}}}}}}}}, "p": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}}, "df": 4}}}}}}}}, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 2}}}}}}, "r": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 2}}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 2}}}}}, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 2}}}}}}}}}}}, "bases": {"root": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}}, "df": 3}}}}}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}}, "df": 5, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 12}}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1.4142135623730951}}, "df": 1, "b": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}}, "df": 1}}}}}}}}, "c": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}}, "df": 2}}}}}}}}}, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}}, "df": 3}}}}}}}}}, "a": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}}}}}}, "b": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.plottable.Plottable": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1.4142135623730951}}, "df": 3}}}, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}}, "df": 1}}}}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}}, "df": 6, "s": {"docs": {"ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}}, "df": 6}}}}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}}, "df": 4, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 3}}}}}}}}}}}}}}}}}}}, "u": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}}, "df": 2}}}}}, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}}, "df": 1}}}}}}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"2": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}}, "df": 19}, "docs": {}, "df": 0}}}}}}}}}, "b": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}}, "df": 10}}}, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}}, "df": 2}}}}, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 12}}}, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor": {"tf": 1}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor": {"tf": 1}}, "df": 4}}}}}}}}}}}}}}}}}, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1.4142135623730951}}, "df": 9}}}}}}}}, "y": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 14}}}}}, "b": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}}, "df": 2}}}}}}}}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 4}}}}}}, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}}, "df": 3}}}}, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}}, "df": 2}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}}, "df": 5}}}}}}, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "[": {"docs": {}, "df": 0, "~": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}}, "df": 5}}}}}}}}}}}}}}}}}}}}}}}}}}, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 3}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1.4142135623730951}}, "df": 6, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}}, "df": 2}}}}}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}}, "df": 3}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 3}}}}}}}}}}}, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}}}}}}, "doc": {"root": {"0": {"0": {"0": {"1": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3}, "2": {"7": {"7": {"7": {"8": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}, "4": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}, "5": {"5": {"5": {"5": {"6": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2": {"tf": 3.605551275463989}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 6}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 4.358898943540674}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 7.211102550927978}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 26, "}": {"docs": {}, "df": 0, "^": {"docs": {}, "df": 0, "{": {"docs": {}, "df": 0, "i": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}}}}}, "1": {"0": {"0": {"0": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 2}}, "df": 3}, "docs": {"ramanchada2": {"tf": 2.6457513110645907}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 19}, "2": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1}, "6": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1}, "8": {"0": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}}, "df": 22}, "1": {"0": {"3": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "b": {"docs": {"ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 1}}}}}}}}}}, "docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1}, "1": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1}, "3": {"7": {"docs": {}, "df": 0, "/": {"0": {"9": {"0": {"5": {"0": {"2": {"1": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "1": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 2}, "3": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}, "4": {"4": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}, "5": {"0": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 3}, "5": {"9": {"6": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 3}, "6": {"0": {"2": {"3": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}, "docs": {}, "df": 0}, "docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 2}, "7": {"8": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 1}, "9": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}, "8": {"0": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}}, "df": 1}, "1": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 2}, "9": {"7": {"8": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"4": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2": {"tf": 3.605551275463989}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 4.358898943540674}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 3.3166247903554}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 5.656854249492381}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 4.47213595499958}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 4.47213595499958}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}}, "df": 26, "}": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}, "{": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}, "+": {"docs": {}, "df": 0, "\\": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "{": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "}": {"docs": {}, "df": 0, "{": {"docs": {}, "df": 0, "\\": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "q": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}}}}}}}}}}}}}}}}}}, "]": {"docs": {}, "df": 0, "*": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 5}}}}}, "/": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "q": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}}, "df": 2}, "f": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}, "2": {"0": {"0": {"0": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 8}, "4": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 5}, "2": {"4": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 2}, "2": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 2}, "8": {"3": {"2": {"5": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 4.47213595499958}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 19, "}": {"docs": {}, "df": 0, "{": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}, "3": {"0": {"0": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}, "4": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "3": {"3": {"3": {"3": {"3": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "5": {"0": {"0": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}}, "df": 1}, "9": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "6": {"0": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 3.4641016151377544}}, "df": 1}, "1": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}}, "df": 1}, "docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 1}, "9": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 5.291502622129181}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 4.242640687119285}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 8.246211251235321}}, "df": 4}, "docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 4.69041575982343}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 3.4641016151377544}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 11}, "4": {"0": {"0": {"0": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 9}, "docs": {}, "df": 0}, "docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 3}, "docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 3.3166247903554}}, "df": 4}, "5": {"0": {"0": {"0": {"0": {"0": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 8}, "3": {"2": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "4": {"0": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {"ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 8}, "6": {"3": {"3": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 7}, "7": {"1": {"9": {"3": {"7": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "2": {"0": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}}, "df": 1}, "docs": {}, "df": 0}, "7": {"1": {"7": {"1": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "8": {"3": {"0": {"docs": {"ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "5": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}}, "df": 5}, "docs": {}, "df": 0}, "docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2}}, "df": 2}, "8": {"6": {"1": {"7": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 2}, "docs": {}, "df": 0}, "7": {"6": {"2": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}}, "df": 3}, "9": {"0": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}, "7": {"8": {"0": {"8": {"9": {"8": {"7": {"1": {"7": {"9": {"5": {"2": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 7, "/": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8, "/": {"docs": {}, "df": 0, "#": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}}, "df": 5}}}}}}}}}}}}}}}}}}}}}}}}}}}}, "docs": {"ramanchada2": {"tf": 33.88214869219483}, "ramanchada2.auxiliary": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra.datasets2": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra.datasets2.data": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra.datasets2.df": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra.datasets2.loc": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra.datasets2.filtered_df": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra.datasets2.get_filters": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra.datasets2.get_filenames": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra.datasets2.prepend_prefix": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra.simulated": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra.simulated.loc": {"tf": 1.7320508075688772}, "ramanchada2.auxiliary.spectra.simulated.FILES": {"tf": 1.7320508075688772}, "ramanchada2.io": {"tf": 1.7320508075688772}, "ramanchada2.io.HSDS": {"tf": 1.7320508075688772}, "ramanchada2.io.HSDS.logger": {"tf": 1.7320508075688772}, "ramanchada2.io.HSDS.write_nexus": {"tf": 1.7320508075688772}, "ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1.7320508075688772}, "ramanchada2.io.HSDS.sanitize_key": {"tf": 1.7320508075688772}, "ramanchada2.io.HSDS.write_cha": {"tf": 1.7320508075688772}, "ramanchada2.io.HSDS.read_cha": {"tf": 1.7320508075688772}, "ramanchada2.io.HSDS.filter_dataset": {"tf": 1.7320508075688772}, "ramanchada2.io.HSDS.visit_domain": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.bw_format": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.bw_format.bw_format": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.neegala_format": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.neegala_format.neegala_format": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.binary_readers": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 5.196152422706632}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_4byte_datablock": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_bytestring": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.binary_readers.read_ngs_meta": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.io": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.io.parse": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.io.cleanMeta": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.third_party_readers": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readWDF": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readSPC": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.third_party_readers.readOPUS": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.logger": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.read_JCAMP": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.readTXT": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.dataFromTxtLines": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.isDataLine": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.startStop": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rc1_parser.txt_format_readers.getYDataType": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.read_csv": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.read_csv.read_csv": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.read_spe": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.read_txt": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.read_txt.read_txt": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rruf_format": {"tf": 1.7320508075688772}, "ramanchada2.io.experimental.rruf_format.rruf_format": {"tf": 1.7320508075688772}, "ramanchada2.io.output": {"tf": 1.7320508075688772}, "ramanchada2.io.output.write_csv": {"tf": 1.7320508075688772}, "ramanchada2.io.output.write_csv.write_csv": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.crystal": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.crystal.discrete_lines_dat": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.crystal.discrete_lines_dat.lines_from_crystal_dat": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.crystal.discrete_lines_out": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.crystal.discrete_lines_out.lines_from_crystal_out": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.lines_from_raw_dat": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.lines_from_raw_dat.lines_from_raw_dat": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.read_simulated_lines": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.read_simulated_lines.read_simulated_lines": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.vasp": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat": {"tf": 1.7320508075688772}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 2}, "ramanchada2.misc": {"tf": 1.7320508075688772}, "ramanchada2.misc.base_class": {"tf": 1.7320508075688772}, "ramanchada2.misc.base_class.BaseClass": {"tf": 1.7320508075688772}, "ramanchada2.misc.base_class.BaseClass.origin": {"tf": 1.7320508075688772}, "ramanchada2.misc.base_class.BaseClass.origin_list_str": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.PST_RS_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_nist_wl_nm": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.polystyrene_rs": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_spe": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_spe": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_785_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_633_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_532_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_514_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_514_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_532_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_633_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_rs_785_nist_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_D3_3": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.neon_wl_D3_3_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.constants.NEON_WL": {"tf": 1.7320508075688772}, "ramanchada2.misc.exceptions": {"tf": 1.7320508075688772}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1.7320508075688772}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1.7320508075688772}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1.7320508075688772}, "ramanchada2.misc.plottable": {"tf": 1.7320508075688772}, "ramanchada2.misc.plottable.Plottable": {"tf": 1.7320508075688772}, "ramanchada2.misc.plottable.Plottable.plot": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.dynamically_added": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_filters": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.dynamically_added.dynamically_added_constructors": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_constructor": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.__init__": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_constructor.add_spectrum_constructor.set_proc": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_filter": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_filter.logger": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_filter.add_spectrum_filter": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_method": {"tf": 1.7320508075688772}, "ramanchada2.misc.spectrum_deco.spectrum_method.add_spectrum_method": {"tf": 1.7320508075688772}, "ramanchada2.misc.types": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.valuesdict": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.locations": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhm": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.boundaries": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.center_amplitude": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.centers_err": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.fwhms": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.amplitudes": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.dumps": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.loads": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_dataframe_peaks": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.to_csv": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult.gen_fake_spectrum": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 12.409673645990857}, "ramanchada2.misc.types.peak_candidates.PeakModel.amplitude": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel.position": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel.sigma": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel.skew": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel.fwhm": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel.serialize": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 2.23606797749979}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 12.409673645990857}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peaks": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_slope": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.base_intercept": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.boundaries": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_baseline": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.plot_params_errorbar": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.positions": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.sigmas": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.fwhms": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.lwhms": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.rwhms": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.skews": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.amplitudes": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.bases": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.peak_bases": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.serialize": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 2.23606797749979}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 6.4031242374328485}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.root": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_ampl_pos_fwhm": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.get_pos_ampl_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel.serialize": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.positive_not_multiple": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.positive_not_multiple.PositiveOddInt": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 12.409673645990857}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 2}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.serialize": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 2.23606797749979}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 6.4031242374328485}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel.serialize": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 12.409673645990857}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.proc": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.args": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.kwargs": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.is_constructor": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.check_proc": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 3.1622776601683795}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 2.23606797749979}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 6.4031242374328485}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.root": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.append": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.extend_left": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.pop": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.clear": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.assign": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.repr": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.cache_path": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel.to_list": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.metadata": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldTyping": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 6.4031242374328485}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.root": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.pre_validate": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel.serialize": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 6.4031242374328485}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.root": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.pre_validate": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.serialize": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.argmin2d": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.argmin2d.argmin2d": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs_idx": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.argmin2d.find_closest_pairs": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 2.23606797749979}, "ramanchada2.misc.utils.argmin2d.align_shift": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.match_peaks_cluster": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.cost_function_position": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 4.123105625617661}, "ramanchada2.misc.utils.matchsets.normalize_tuples": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.cost_matrix_peaks": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 11.575836902790225}, "ramanchada2.misc.utils.ramanshift_to_wavelength": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1_dict": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.ramanshift_to_wavelength.abs_nm_to_shift_cm_1": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.ramanshift_to_wavelength.shift_cm_1_to_abs_nm": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.ramanshift_to_wavelength.laser_wl_nm": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.svd": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.svd.svd_solve": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.svd.svd_inverse": {"tf": 1.7320508075688772}, "ramanchada2.protocols": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_calibration": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 6.557438524302}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.neon_silicon_calibration": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.logger": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.ProcessingModel": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.nonmonotonic": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.laser_wl": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.spe_units": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.ref_units": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.name": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.model_units": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.peaks": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.sample": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.enabled": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fit_res": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.set_model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.convert_units": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.process": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.derive_model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.plot": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent.fitres2df": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 14.966629547095765}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.prominence_coeff": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_curve": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_zero": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.apply_calibration_x": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.plot": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.calibration_model_factory": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.logger": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.spe_pos_dict": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_method": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.cost_function": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.interpolator_method": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.extrapolate": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.process": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.derive_model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.match_peaks": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent.fit_peaks": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.profile": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.derive_model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.zero_nm_to_shift_cm_1": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent.process": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 26.49528259898354}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.from_dict": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.to_dict": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator.plot": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 12.083045973594572}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.x": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.y": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.from_dict": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.to_dict": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 35.93048844644336}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.from_dict": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.to_dict": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator.plot": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 14.352700094407323}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.id": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.description": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.url": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.wavelength": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.params": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.equation": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.temperature_c": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.raman_shift": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.response_function": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.Y": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.load": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 2}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 13.784048752090222}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load_certificates": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_laser_wl": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get_certificates": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.get": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict.load": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 16.0312195418814}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.laser_wl": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.spe": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.ref": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.name": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.model_units": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.derive_model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_divide": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_mask": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.safe_factor": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent.process": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.MetadataExtractor": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.MetadataExtractor.extract": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.template": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.TemplateMetadataExtractor.extract": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.FilenameMetadataExtractor.extract": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.SpectrumMetadataExtractor.extract": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extractors": {"tf": 1.7320508075688772}, "ramanchada2.protocols.metadata_helper.ChainedMetadataExtractor.extract": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 12.409673645990857}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.file_name": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.sample": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.provider": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.device_id": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_wl": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_mW": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.laser_power_percent": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.time_ms": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.replicate": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.optical_path": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.spectrum": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.Config.arbitrary_types_allowed": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 3.1622776601683795}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 33.793490497431605}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 4.58257569495584}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 5.477225575051661}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_metadata": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_template": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.average": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.trim": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.baseline_snip": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.spe_area": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 33.95585369269929}, "ramanchada2.protocols.twinning": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 10.099504938362077}, "ramanchada2.protocols.twinning.TwinningComponent.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.grouping_cols": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.twinned": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.reference": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.boundaries": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_reference": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.linreg_twinned": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.correction_factor": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.reference_band_nm": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.normalize_by_laserpower_time": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.calc_peak_intensity": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.laser_power_regression": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.process": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.derive_model": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent.plot": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.baseline.analytical": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.baseline.baseline_base": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.baseline.numerical": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 4}, "ramanchada2.spectral_components.peak_profile": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.delta": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.__init__": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.a": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.x0": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.delta": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.pos_amp_fwhm": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak.limit_3sigma": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.gauss": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.__init__": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.a": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.x0": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.w": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.delta": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.pos_amp_fwhm": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak.limit_3sigma": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.voigt": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_component": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_component_collection": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.__init__": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.kwargs": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.reset_origin": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_deltas": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.get_curve": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection.limit_3sigma": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_peak": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.delta": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.limit_3sigma": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak.pos_amp_fwhm": {"tf": 1.7320508075688772}, "ramanchada2.spectrum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.arithmetics": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.arithmetics.add": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.arithmetics.mul": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.arithmetics.sub": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.arithmetics.truediv": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.generate_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 6.782329983125268}, "ramanchada2.spectrum.baseline.baseline_rc1": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_als": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.baseline_rc1.baseline_snip": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_als": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.baseline_rc1.subtract_baseline_rc1_snip": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.moving_minimum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.moving_minimum.subtract_moving_minimum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calc": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calc.central_moments": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calc.central_moments.central_moments": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.__init__": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.params": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.minx": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.maxx": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.DeltaSpeModel.fit": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 12.409673645990857}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.min": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.max": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 2.23606797749979}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 12.409673645990857}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.shift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.scale3": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 2.23606797749979}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 3.605551275463989}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.calibration.by_deltas.xcal_argmin2d_iter_lowpass": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.change_x_units": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 4.242640687119285}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 4.242640687119285}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 4.242640687119285}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 4.242640687119285}, "ramanchada2.spectrum.calibration.normalize": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 6}, "ramanchada2.spectrum.calibration.scale_xaxis": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 5.656854249492381}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 6.164414002968976}, "ramanchada2.spectrum.calibration.scale_yaxis": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 4.898979485566356}, "ramanchada2.spectrum.calibration.set_new_xaxis": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 5.744562646538029}, "ramanchada2.spectrum.creators": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_cache_or_calc": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_cache_or_calc.logger": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 5}, "ramanchada2.spectrum.creators.from_chada": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_chada.from_chada": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_delta_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 9.848857801796104}, "ramanchada2.spectrum.creators.from_local_file": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 8.888194417315589}, "ramanchada2.spectrum.creators.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 9.055385138137417}, "ramanchada2.spectrum.creators.from_spectral_component_collection": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 4.795831523312719}, "ramanchada2.spectrum.creators.from_stream": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_stream.from_stream": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_test_spe": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 5.385164807134504}, "ramanchada2.spectrum.creators.from_theoretical_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 5.830951894845301}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.generate_add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 7.416198487095663}, "ramanchada2.spectrum.filters.add_poisson_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 6.164414002968976}, "ramanchada2.spectrum.filters.convolve": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 7.211102550927978}, "ramanchada2.spectrum.filters.drop_spikes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 4.898979485566356}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.filters.dropna": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 4.242640687119285}, "ramanchada2.spectrum.filters.moving_average": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 5.291502622129181}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 5.291502622129181}, "ramanchada2.spectrum.filters.moving_median": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.filters.pad_zeros": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 4.795831523312719}, "ramanchada2.spectrum.filters.resampling": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 6.928203230275509}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 6.6332495807108}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 6.708203932499369}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 6.4031242374328485}, "ramanchada2.spectrum.filters.sharpen_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 6.324555320336759}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 5}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 5.196152422706632}, "ramanchada2.spectrum.filters.smoothing": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 5.477225575051661}, "ramanchada2.spectrum.filters.trim_axes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 5.385164807134504}, "ramanchada2.spectrum.peaks": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks.peak_boundaries": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 7.810249675906654}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 5.196152422706632}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 6.928203230275509}, "ramanchada2.spectrum.peaks.fit_peaks": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.fit_peaks.logger": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.fit_peaks.available_models": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.fit_peaks.available_models_type": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.fit_peaks.build_multipeak_model_params": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peak_multimodel": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.peaks.get_fitted_peaks": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.get_fitted_peaks.logger": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 7.416198487095663}, "ramanchada2.spectrum.spectrum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.logger": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.__init__": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.applied_processings_dict": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.write_csv": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.write_cha": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.write_nexus": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.write_cache": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.process": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.apply_creator": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.apply_processing": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.x": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.x_bin_boundaries": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_MAD": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol_DL": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_noise_savgol": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.x_err": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.y_err": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.meta": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.result": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.spe_distribution": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.gen_samples": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_minimum": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_als": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_baseline_rc1_snip": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 6.782329983125268}, "ramanchada2.spectrum.spectrum.Spectrum.central_moments": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 4.898979485566356}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 6}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 4.242640687119285}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 4.242640687119285}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 4.242640687119285}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 4.242640687119285}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 3.605551275463989}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_argmin2d_iter_lowpass": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 5.744562646538029}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 5.656854249492381}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 6.164414002968976}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 5}, "ramanchada2.spectrum.spectrum.Spectrum.from_chada": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 9.848857801796104}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 8.888194417315589}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 9.055385138137417}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 4.795831523312719}, "ramanchada2.spectrum.spectrum.Spectrum.from_stream": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 5.385164807134504}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 5.291502622129181}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 5.291502622129181}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 5.830951894845301}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 6.164414002968976}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 7.211102550927978}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 6.324555320336759}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 5}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 5.196152422706632}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 4.898979485566356}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 5.5677643628300215}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 5.385164807134504}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 7.416198487095663}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 6.928203230275509}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 6.6332495807108}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 6.708203932499369}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 6.4031242374328485}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 4.795831523312719}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 4.242640687119285}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 5.477225575051661}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 6.928203230275509}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 7.416198487095663}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 7.810249675906654}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 5.196152422706632}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_multimodel": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 5.5677643628300215}, "ramanchada2.theoretical_lines": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.model_from_lines": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 12.409673645990857}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.position": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.inensity": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.sigma": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.name": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 3.1622776601683795}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 2.23606797749979}, "ramanchada2.theoretical_lines.model_from_lines.model_from_list": {"tf": 1.7320508075688772}}, "df": 702, "p": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 3}}, "df": 2, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 9}}}}}}, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}}, "df": 1}}}}}, "r": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.7320508075688772}}, "df": 3, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 2, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 5, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 20}}}}}, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 4}}, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 4, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}}, "df": 3}}}}}}}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 9, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}}}, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 5, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 12}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "i": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 9}}}, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 6}}, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}}, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}}, "df": 1, "d": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 15}, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}}, "df": 17}, "r": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}}, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 2}}}}}, "c": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 3, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 2, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 5}}}}}}, "d": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}}, "df": 1, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 3}}}}}}}, "o": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}}, "df": 3}}}}}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 4}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}}, "df": 4}}}}}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 3}}}}}}, "d": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}}, "df": 3}}}}, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}}, "df": 1}}}}}}}, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 4}}}}}}}, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}}, "df": 3, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}}, "df": 4}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}}, "df": 1}}}}}}}, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}}}, "v": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "f": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 3}}}}}}, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 4}}}}}, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 2}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 2}}, "df": 13}}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.7320508075688772}}, "df": 3, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 2, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}}}}}}, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}}}}}}, "f": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}}, "df": 5}}}}}, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3.3166247903554}}, "df": 1}}}}}}, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 5}}}}}}, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2": {"tf": 3.4641016151377544}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 14, "s": {"docs": {"ramanchada2": {"tf": 3.7416573867739413}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.4142135623730951}}, "df": 12}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 3}}}}}}}}, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"4": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 4}, "docs": {}, "df": 0}}}}}, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}}, "df": 1}}}}, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.7320508075688772}}, "df": 1}}}}}}}, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.4142135623730951}}, "df": 6, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 2}}}}}}}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}, "y": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.7320508075688772}}, "df": 1, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 3}}, "s": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}}, "df": 6}}}}}}, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 8}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}}, "df": 3, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.23606797749979}}, "df": 4, "s": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 5}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}}}}, "w": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 1, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 2}}}}, "y": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 4.47213595499958}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 4.47213595499958}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 4.47213595499958}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 4.47213595499958}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 4.47213595499958}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 4.47213595499958}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 4.47213595499958}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 4.47213595499958}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.4142135623730951}}, "df": 31}}}}}}, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 7, "h": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}}, "df": 1}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 4}}}}, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 4}, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.7320508075688772}}, "df": 5}}}, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}}}}}}}, "v": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 3}}}}}, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 7, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}, "i": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 2}}}}}}}}, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 2}}}}, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 3.3166247903554}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}}, "df": 4, "f": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 2}}}, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}}, "df": 1, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 3, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"1": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 3}, "2": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.7320508075688772}}, "df": 2}, "docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "s": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 9}}}}}}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 2}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}}, "df": 14}}}, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 3.4641016151377544}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}}, "df": 15, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}, "k": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}}, "df": 1}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 7}}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 4}}}}, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.449489742783178}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 5}, "s": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 3}}}}, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 3}}}}, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 3}}}, "i": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 9}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 3.605551275463989}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 26, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 5}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 15}}}, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 3}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 11, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 3}}}}}}, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}}, "df": 3, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 1, "f": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}}}}}, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 4, "s": {"docs": {"ramanchada2": {"tf": 5.830951894845301}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 75}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 10}}}}}}, "d": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}}, "df": 5}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}}, "df": 5, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}}, "df": 3}}}}, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}}, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 7}}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}}, "df": 3}}}, "r": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}}, "df": 3}}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 4.47213595499958}}, "df": 1}}}}}}}, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 17}, "d": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 9}}}}, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.7320508075688772}}, "df": 3}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}}}, "b": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}}}, "f": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 3}}, "df": 3, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 3}}}}}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 1}}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "g": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2}}, "df": 1}}}}}}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}}, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 2.6457513110645907}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}}, "df": 10}}, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 10}}}}, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}}, "c": {"1": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}, "2": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}}, "df": 1, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}}, "df": 1}}}}}}, "docs": {}, "df": 0}, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}}, "df": 3}}}}}, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.7320508075688772}}, "df": 13, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 13}}}}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}, "w": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}, "b": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 3.1622776601683795}}, "df": 2, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 4}}}}}}}}}}}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}}, "df": 1}}}, "*": {"docs": {}, "df": 0, "*": {"2": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}}, "df": 1}, "3": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}}, "df": 3, "o": {"docs": {"ramanchada2": {"tf": 2}}, "df": 1, "f": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.449489742783178}}, "df": 1}}}}}}, "l": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.misc.utils.svd.svd_solve": {"tf": 1}}, "df": 1}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}}}, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "g": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 3}}}, "p": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3, "e": {"docs": {"ramanchada2": {"tf": 8.246211251235321}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 2}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.4142135623730951}}, "df": 80, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}, "a": {"docs": {"ramanchada2": {"tf": 3.1622776601683795}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 10, "l": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 3, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 3}}}}}}}}}}}}}}}}}}}}, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 3.1622776601683795}}, "df": 2}}}}}}, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 9.797958971132712}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 2}, "ramanchada2.spectrum.creators.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 97}}}}, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 12}}, "c": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 4}}}}, "*": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}}, "df": 3}}}}}}}, "i": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 3, "s": {"docs": {"ramanchada2": {"tf": 3.3166247903554}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}}, "df": 9}}}}, "c": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}, "a": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 4, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3.4641016151377544}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 2}}, "df": 9, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "g": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 9}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 2.6457513110645907}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 23, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3}}}}}, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.4142135623730951}}, "df": 3}}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 11}}}, "e": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 3, "s": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.7320508075688772}}, "df": 3}}}, "r": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 8, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 5}}}}}, "u": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 5, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 4}}}}, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}}, "df": 1, "d": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 5}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3}}}}}}}, "i": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}}, "df": 1, "m": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 3, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 3}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.creators.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 2}}, "df": 4, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}}, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2": {"tf": 3.7416573867739413}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.7320508075688772}}, "df": 13}}, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}}, "df": 5}, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.7320508075688772}}, "df": 8}}}}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 14, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 5}}}, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}}, "df": 1, "g": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 14}}, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}, "l": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}}, "df": 2}}}}}, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.7320508075688772}}, "df": 12}, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 10, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 5}, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}}, "df": 2}}, "g": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}}, "df": 6}}}}, "t": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 2}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 2}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 2}}, "df": 15, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}}, "df": 1}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 6}}}}}}, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 5, "d": {"docs": {"ramanchada2": {"tf": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 12}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3}}}}}, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}}, "df": 3}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 3}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}, "f": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}, "p": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}}, "df": 1, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}}, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 1, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 3}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.23606797749979}}, "df": 2, "/": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}}}}}}}, "g": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}}, "df": 1}}}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}}, "df": 8}}}, "e": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}}, "df": 10, "d": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}}, "df": 1}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 3}}}, "t": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "i": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}}, "df": 7}}}, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 9, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}}}}}, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}}}}}, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 2}}}}}, "b": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}}, "df": 2, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}}}}}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}}, "df": 4}}}}}}}, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}}, "df": 8, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 7}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 5}}}}}}}}, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 3}}}}}}, "c": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 11, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}}}, "f": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}}}, "m": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}}, "df": 7}}, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 2}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}}, "df": 22}}}, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3}}, "w": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}}, "df": 3}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 3, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 3.3166247903554}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.7320508075688772}}, "df": 9}}}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 9, "s": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 2}}, "df": 3}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}, "q": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1, "{": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "*": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}}, "df": 3}}}}}}}}}}, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.7320508075688772}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 4, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.449489742783178}}, "df": 2}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 3}}}}}}, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}, "y": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 2, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 2}}}}}, "r": {"docs": {}, "df": 0, "m": {"2": {"2": {"4": {"1": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}}, "df": 2}}}, "i": {"4": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {"ramanchada2": {"tf": 5.385164807134504}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 4.47213595499958}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 4.47213595499958}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.7320508075688772}}, "df": 15, "s": {"docs": {"ramanchada2": {"tf": 8.717797887081348}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 4.69041575982343}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 5.0990195135927845}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.8284271247461903}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 2.23606797749979}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 2}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.7320508075688772}}, "df": 77}, "n": {"docs": {"ramanchada2": {"tf": 7.0710678118654755}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 84, "t": {"6": {"4": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {}, "df": 0}, "8": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}}, "df": 1}, "docs": {"ramanchada2": {"tf": 3.4641016151377544}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 30, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 7.874007874011811}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.4142135623730951}}, "df": 74}}}, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}}, "df": 2, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 4, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}}, "df": 15}}, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 2}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}}, "df": 2, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 3, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}}, "df": 3}}}}}}, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 1}}}}, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2}}, "df": 3}}}, "y": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.4142135623730951}}, "df": 5}}}}}, "g": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}}, "df": 3}, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}, "o": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}}, "df": 1}}, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 5}}}, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 2}}}}}}, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}}, "f": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 5}}}}}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 2.23606797749979}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 2.23606797749979}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 2.23606797749979}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 2.23606797749979}}, "df": 10, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 5, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 2}}}}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 11, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 9}}}, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}}}}, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 4}}}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 8}}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 3.605551275463989}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 3.3166247903554}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.4142135623730951}}, "df": 5, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}}, "df": 6}}}}}, "p": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.4142135623730951}}, "df": 9, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 2}}}}, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 3}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}}, "df": 14}}}}}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 2}}}}}}}}}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 4}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}}, "t": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 14, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 3, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}}, "df": 1}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 5}}}}, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}}, "df": 1}}, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 2, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}, "d": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 4}}}}}}}}, "f": {"docs": {"ramanchada2": {"tf": 6.782329983125268}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.8284271247461903}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.8284271247461903}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 2}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2.23606797749979}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2.23606797749979}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.7320508075688772}}, "df": 53}, "g": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 3, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}}, "df": 4}}}}}}, "*": {"docs": {}, "df": 0, "\u03b4": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 3}}}, "}": {"docs": {}, "df": 0, "*": {"docs": {}, "df": 0, "{": {"docs": {}, "df": 0, "\\": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}}, "df": 3}}}}}}}}}, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1, "t": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1, "h": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 2}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 16, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 4}}}}, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 2}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 25}}}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.4142135623730951}}, "df": 3}}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}}, "df": 5}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}}, "u": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.449489742783178}}, "df": 2, "t": {"docs": {}, "df": 0, "i": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 4}, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}}, "df": 4}, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.7320508075688772}}, "df": 7}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.449489742783178}}, "df": 1}}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.7320508075688772}}, "df": 1}}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 6}}, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 4}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 1, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 4.123105625617661}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 4.123105625617661}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 2.449489742783178}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 4.123105625617661}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 2.449489742783178}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 4.123105625617661}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 2.449489742783178}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 2.449489742783178}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 2.449489742783178}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 4.123105625617661}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 4.123105625617661}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 4.123105625617661}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 4.123105625617661}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.4142135623730951}}, "df": 40, "s": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.7320508075688772}}, "df": 10}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}}, "df": 1}}}}}}, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 4.47213595499958}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 42}}}}}, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}, "o": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}, "v": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 3, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 4.58257569495584}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}}, "df": 21}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 5}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "f": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 3}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 3}}, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 4}}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 7, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "e": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}}, "df": 1}}}, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 3.605551275463989}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}}, "df": 18}}, "a": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 5}}}, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 3}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}}}, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 5}}}}}, "g": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 5}}}, "d": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 3}}}}, "s": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}}, "df": 1}, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}}, "df": 1}}}}, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}}}}, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 4, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 3}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}}, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 4}}, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 4, "e": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "{": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}}}}}}, "c": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}}, "df": 7, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2.23606797749979}}, "df": 1}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 2}}}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}, "x": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 4, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 3}}, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 3}}}}}, "y": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 11}, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 11}}}}}}, "g": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}, "w": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}, "s": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}}, "df": 1, "o": {"docs": {"ramanchada2": {"tf": 10.63014581273465}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1.7320508075688772}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 2}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 3.4641016151377544}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 3.3166247903554}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 4.242640687119285}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.23606797749979}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2.449489742783178}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 2}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 2}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2.449489742783178}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2.449489742783178}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 112, "o": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "l": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}, "p": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 3}}, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}}, "h": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.7320508075688772}}, "df": 3, "e": {"docs": {"ramanchada2": {"tf": 13.820274961085254}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 4.795831523312719}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 4.795831523312719}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 2.6457513110645907}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 4.795831523312719}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 2.6457513110645907}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 4.795831523312719}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 2.6457513110645907}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 2.6457513110645907}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 2.6457513110645907}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 6.6332495807108}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 4.58257569495584}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 7.280109889280518}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 4.795831523312719}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.449489742783178}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 4.47213595499958}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 4.795831523312719}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 4.795831523312719}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 3.3166247903554}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 3}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 2.23606797749979}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 3}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 3}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 3}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 3}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 3}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 2}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 3.3166247903554}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 3}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 3}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 3}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 3}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 3}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 3}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 4.795831523312719}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.4142135623730951}}, "df": 132, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 2.449489742783178}}, "df": 1}}}}}}}}, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 11}}, "m": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 3}, "y": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 10}}, "i": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 11}}, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}}, "df": 3}, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}}, "df": 1}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 3.3166247903554}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 38}, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}}, "df": 1}, "r": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}}, "df": 19}, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 4}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 3.3166247903554}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.7320508075688772}}, "df": 12}}}}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}}, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}, "g": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}}, "df": 4}}, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 3}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}}}}}}}}, "x": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1, "n": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 5}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3}}}}}, "b": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "u": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 14, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 2}}}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 5, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3}}}}}}}}, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}, "i": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}}, "df": 5, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 5}}}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 4.47213595499958}}, "df": 1}}}}}}, "y": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.7320508075688772}}, "df": 6, "s": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 11}}}, "o": {"2": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}}, "x": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}}, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3.1622776601683795}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 8, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}}, "df": 5}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}, "w": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 3}, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}, "n": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 1}, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}}}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 3}}, "df": 1}}}}}}, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2.6457513110645907}}, "df": 2, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}, "f": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2.449489742783178}}, "df": 2, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.23606797749979}}, "df": 2}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 4.358898943540674}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 21, "s": {"docs": {"ramanchada2": {"tf": 2}}, "df": 1}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}}, "df": 3}}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 3}}}}}}}, "e": {"docs": {"ramanchada2": {"tf": 4.123105625617661}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 2.23606797749979}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 2.6457513110645907}}, "df": 13, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe": {"tf": 1}}, "df": 4}, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 4}}}}, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.7320508075688772}}, "df": 3}}}}}}, "t": {"docs": {"ramanchada2": {"tf": 3.3166247903554}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.7320508075688772}}, "df": 10, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 3}}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 7}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 3.605551275463989}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.4142135623730951}}, "df": 14, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 3}}}, "s": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1.4142135623730951}}, "df": 1}}, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}}, "df": 4}}}, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 18, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.7320508075688772}}, "df": 22}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1.4142135623730951}}, "df": 9}}}}}}}, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 3, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 2}}}}, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}}, "df": 1}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 3}}}}}}, "w": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 3}}, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 6}, "ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2.449489742783178}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 2.23606797749979}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 2.23606797749979}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 2}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 2.23606797749979}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}}, "df": 80, "m": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 3, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.io.experimental.read_spe.read_spe": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 3, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}}, "df": 3}}, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 5}}}}}, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "c": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 3.1622776601683795}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 2}}, "df": 10, "y": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}}, "df": 1}}}}}, "l": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 15}}}}, "u": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 3, "c": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.7320508075688772}}, "df": 3, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 8.888194417315589}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 30, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 5}}}}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 5}}}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 3}}}}}, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}}, "df": 2}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 5.291502622129181}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 3.605551275463989}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 2}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 53}}, "e": {"docs": {}, "df": 0, "q": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}}, "df": 3, "u": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 5}, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3}}}}}}}}}, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 3}}}}, "{": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.7320508075688772}}, "df": 1}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 1}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 13}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 1}}}}}}, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}}, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 5}}}, "g": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}}, "df": 8, "a": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 2}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 12, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}}}}}}, "u": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}}}}, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 2}}}}, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 7, "d": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 3}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 11}}}, "l": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 8, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}, "t": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}}, "df": 5}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}}, "df": 3}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.7320508075688772}}, "df": 1}}}}}}, "i": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "e": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 1}}}}, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 6.928203230275509}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 9.797958971132712}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 3.4641016151377544}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 4.898979485566356}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 8.18535277187245}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 7.3484692283495345}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 11}, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}}, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}, "o": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}, "v": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "/": {"2": {"2": {"4": {"1": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}}}}}}}}}}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}}, "df": 2}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}}}}, "b": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2}, "ramanchada2.misc.utils.svd.svd_solve": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.23606797749979}}, "df": 7, "e": {"docs": {"ramanchada2": {"tf": 7.874007874011811}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 3.4641016151377544}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 2}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}}, "df": 74, "t": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 4}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}}, "df": 3}}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 4}}, "f": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 4}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 4}}}}, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 1}}}}}}, "y": {"docs": {"ramanchada2": {"tf": 3.872983346207417}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.449489742783178}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 23}, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 8, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 3, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}}, "df": 2}}}}}}}}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 13, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 3.3166247903554}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 2.449489742783178}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 2.449489742783178}}, "df": 7}}}}, "d": {"docs": {"ramanchada2": {"tf": 3.1622776601683795}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 21}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}}, "df": 5}}}}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 5}, "c": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3}}}}}}}, "y": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 5, "g": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 3}}}}}}}}}}}}}}}}}}}}}, "c": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}}}}}, "o": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}}, "df": 12}}, "h": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3}}}}, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.8284271247461903}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}}, "df": 7}, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.7320508075688772}}, "df": 4}}}}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}, "o": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 4}, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 11, "s": {"docs": {"ramanchada2": {"tf": 3.605551275463989}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}}, "df": 15}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}, "g": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 3}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 5}}}}}}}}}}}}}, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3}}, "df": 1}}, "a": {"0": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1.4142135623730951}}, "df": 1}, "1": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1.4142135623730951}}, "df": 1}, "2": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1.4142135623730951}}, "df": 1}, "3": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1.4142135623730951}}, "df": 1}, "4": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1.4142135623730951}}, "df": 1}, "5": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {"ramanchada2": {"tf": 5.385164807134504}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 2.23606797749979}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 3.872983346207417}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 5.385164807134504}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 4.898979485566356}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 3.4641016151377544}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 3}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 2.23606797749979}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 2.23606797749979}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 2.23606797749979}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 88, "n": {"docs": {"ramanchada2": {"tf": 2.6457513110645907}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 28, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2.23606797749979}}, "df": 2}}}}, "o": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 9}}}}}, "d": {"docs": {"ramanchada2": {"tf": 6.557438524302}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1.4142135623730951}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 4.69041575982343}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2.23606797749979}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 75}, "y": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 6}, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}}}}}}}}}, "g": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 4.358898943540674}}, "df": 1}}}}}, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 19}}, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}, "s": {"docs": {"ramanchada2": {"tf": 2}}, "df": 1}, "c": {"docs": {"ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}}, "df": 14}}, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 5}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 36, "a": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 3}}, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}}}}, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 8}}}}}}}, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 7}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 17}, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 4, "s": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 98}}}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"2": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "docs": {}, "df": 0}}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.4142135623730951}}, "df": 15, "s": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}}, "df": 3}}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}}, "df": 1}}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}}, "df": 2}}}}}}}}}, "l": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 4}}}}}}}, "l": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 12, "o": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 2}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "c": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}, "o": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}}}}, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 6}}}, "w": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 4}}}}, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "o": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 5}}, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 2}}}}}}}}, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.8284271247461903}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 7, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 2}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 2}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 2}}, "df": 15}}}}}}}}}, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "d": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "d": {"docs": {"ramanchada2": {"tf": 3.4641016151377544}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.23606797749979}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}}, "df": 12, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}}, "df": 12}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 6, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 5}}}}}}}, "s": {"docs": {"ramanchada2": {"tf": 5.0990195135927845}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 2}}, "df": 33, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 8}}}, "y": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 4}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}}, "p": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 4}}}}}}, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 3, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}, "x": {"docs": {"ramanchada2.misc.utils.svd.svd_solve": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3.872983346207417}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 2}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 2.6457513110645907}}, "df": 5, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}}, "df": 7}}, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 4.358898943540674}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3.3166247903554}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 34}}}, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 4.898979485566356}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 6}}}}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 7, "d": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.7320508075688772}}, "df": 1}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}}}}, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}}, "c": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}}, "df": 1}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}}, "df": 5, "s": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}}, "df": 7}}}}}}}}, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}}}, "k": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"1": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}}}}}}}}}}}, "docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}, "g": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}}, "df": 1}}}}}}, "f": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 7, "x": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 4, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 5}}}}}}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 4}}, "s": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 4}}}}}}}, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.7320508075688772}}, "df": 3, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3}}}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 9, "s": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 5}}}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 2}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}}}, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 3}}}, "r": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 2}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 2}}, "df": 13, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}}, "df": 2}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}}, "df": 5}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 2, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}}, "df": 5}}}}}}}, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}, "c": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 11}}}, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 3}}}}}}, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 2, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}}, "df": 1}, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}, "f": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.7320508075688772}}, "df": 1, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}}, "df": 3}}, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}}}, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}}, "df": 1}, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}}}}}}, "r": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 3, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}}, "df": 3}}}}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}}, "df": 1}}}}}}}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 3, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}}}, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}}}}, "p": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}, "f": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}, "t": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}, "u": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}}}}}}}}}, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 3.3166247903554}}, "df": 5, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 2}}, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 3}}}}}}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 3, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}}, "df": 6}}}}}, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}}}, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 9, "d": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}, "x": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1, "d": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 11, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 9}}}}}}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}}, "df": 5}}, "a": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 3, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 10}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 13}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}}, "df": 1}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 9}}}, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 3}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}}, "df": 17, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}}, "df": 9}}}}}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1.4142135623730951}}, "df": 17}}}}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}}, "df": 9}}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 3, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 4, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 2}}}}, "r": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.449489742783178}}, "df": 2}}, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": null}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": null}}, "df": 2}}}}}}}, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1}}}}}}}, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.8284271247461903}}, "df": 1, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}}, "df": 1}}}}}}}}, "d": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 3}}}, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}}, "df": 1, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}}, "df": 17}}, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}}, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 26}}}}}}}}}}, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 2}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 2}}, "df": 8, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 3}}}}}}}}}}, "e": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}}, "df": 3, "*": {"docs": {}, "df": 0, "\\": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}}}}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 4, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}}, "df": 5}}}}}}}}}}, "l": {"1": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.449489742783178}}, "df": 1}, "2": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.449489742783178}}, "df": 1}, "docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}}, "df": 3}}}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1.7320508075688772}}, "df": 4, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 3}}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 1, "b": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}, "s": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "t": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 2}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}, "y": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.23606797749979}}, "df": 1}, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}, "r": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 2.449489742783178}}, "df": 3, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 24}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 7, "d": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 15}, "s": {"docs": {"ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 1}}}}}}}, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 3}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.save": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}}, "df": 20, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 2.23606797749979}}, "df": 1}}}}}}}}, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}}, "df": 2, "d": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 1}}}}}}}, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}}, "df": 7}}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 2}}, "df": 1}}}}}}, "n": {"docs": {"ramanchada2": {"tf": 3.3166247903554}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 17, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 3}}}}, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 2.23606797749979}}, "df": 3, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 3}}}}}}}, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 3}}}}}}, "r": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "u": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"2": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}, "docs": {}, "df": 0}}}}}}}}}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.nonmonotonic": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.7320508075688772}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.7320508075688772}}, "df": 32}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.clear": {"tf": 1}}, "df": 1}}}}, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 14}}}}, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}}, "df": 2, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 3}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}}, "df": 11}}}}}}}}, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.6457513110645907}}, "df": 3, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}}}}, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}}, "df": 2}}}}}}}}}}, "h": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2": {"tf": 2}}, "df": 1, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}}, "df": 5}}, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 5}}}}, "d": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}}}, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}}}, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}, "m": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}}, "df": 2}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 3}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 5, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}}}}, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "/": {"2": {"0": {"2": {"4": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "a": {"1": {"8": {"1": {"3": {"4": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}}}}}}}}}}}, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1.7320508075688772}}, "df": 2, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 2, "s": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 2.23606797749979}}, "df": 2, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}}}}}, "s": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1.4142135623730951}}, "df": 1}}}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3.4641016151377544}}, "df": 1, "v": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 4}}, "d": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 9}}, "[": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}, "i": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 4.47213595499958}}, "df": 2}}}}}, "w": {"docs": {}, "df": 0, "a": {"1": {"8": {"1": {"3": {"4": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}}, "df": 7, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.7320508075688772}}, "df": 3, "a": {"docs": {"ramanchada2": {"tf": 3.605551275463989}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 3.7416573867739413}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 4.58257569495584}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 19, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 3}}}, "f": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 4.898979485566356}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 4.242640687119285}}, "df": 5, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.449489742783178}}, "df": 1}}}}}}, "c": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2}}, "df": 1, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}}}}}, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 8, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 10}}}}}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 4}}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}}}}}}}, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}}, "df": 2, "s": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1}}}}}}, "c": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 5}}}}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 2}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.8284271247461903}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 7, "[": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 3}}}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 5}}}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_config": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_config": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_config": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_config": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_config": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_config": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_config": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 32}}}}}}, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}}, "df": 1}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 5}}}}}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}}, "df": 2}, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 2}}}}}}}}}, "v": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}}, "df": 1, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.23606797749979}}, "df": 1}}, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}}, "df": 1}}}}}}}, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}}, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 3}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 11}}}}}}, "/": {"2": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 13}, "docs": {}, "df": 0}}, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 5, "d": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 24}, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 3}}}}, "a": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 3.7416573867739413}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}}, "df": 36, "s": {"docs": {"ramanchada2": {"tf": 5.744562646538029}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 2}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2.23606797749979}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 2.449489742783178}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2.23606797749979}}, "df": 24}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 3}}}}}, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 8}}}}}}, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}}, "df": 3}}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}}, "df": 1}}}}}}}, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 7, "s": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.7320508075688772}}, "df": 3}}}, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}}, "r": {"2": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 3}, "4": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}}, "df": 1, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 2.23606797749979}}, "df": 5, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}}, "df": 2}}}}}}, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}}, "df": 1}, "d": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}}, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}}, "df": 3}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 4, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}}}}}, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3}}}}}, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1.4142135623730951}}, "df": 3}}}}}, "g": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 3.3166247903554}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 4.123105625617661}}, "df": 2}}}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}}}}}}}}}, "o": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3, "c": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 13, "t": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 9.433981132056603}}, "df": 1}}}}}}}, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.7320508075688772}}, "df": 3}}}}, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}}, "df": 5}}, "i": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}}, "df": 1}, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}}, "df": 3}}}}}}, "o": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "n": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "x": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}, "l": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}, "p": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}}}}, "f": {"1": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 1}, "2": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2}}, "df": 1}, "3": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.6457513110645907}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 4.123105625617661}}, "df": 5}, "s": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}}, "df": 1}, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}}, "df": 1}}}}, "t": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 3}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}}, "df": 1}}}}}, "y": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1.4142135623730951}}, "df": 2}}}}}}}, "o": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "f": {"docs": {"ramanchada2": {"tf": 8.717797887081348}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 3.3166247903554}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 3.3166247903554}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 3.3166247903554}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 3.3166247903554}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 4}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 4}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 3.3166247903554}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.6457513110645907}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 3.3166247903554}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 3.3166247903554}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 2.23606797749979}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 2.23606797749979}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 3.3166247903554}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 100}, "r": {"docs": {"ramanchada2": {"tf": 4.69041575982343}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 3.1622776601683795}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 39, "i": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}}, "df": 3, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 9, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.plot": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.7320508075688772}}, "df": 5}}}}}, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}, "g": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}, "/": {"1": {"0": {"docs": {"ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}}, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 2}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}}, "df": 8}}}}, "b": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}}}, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}, "j": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 12, "s": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 21}}}}}}, "n": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 32, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 8.246211251235321}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.4142135623730951}}, "df": 80}}, "e": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 14, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}}, "df": 3}}}, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.6457513110645907}}, "df": 2, "w": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}}, "df": 6}}}}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 4}}}}, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}}, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 7.280109889280518}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 2}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2.23606797749979}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 2.449489742783178}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2.23606797749979}}, "df": 60, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}}}, "m": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 3}}, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1}}}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}}}}}, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 5.0990195135927845}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 53}}, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 5, "p": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.spectrum.creators.from_simulation": {"tf": 1}}, "df": 1}}}}}, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}}, "df": 3}}}}}}}, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "c": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}, "v": {"1": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}}, "df": 17}, "docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.7320508075688772}}, "df": 3}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}, "y": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.23606797749979}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2}}, "df": 10, "s": {"docs": {"ramanchada2": {"tf": 5.5677643628300215}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3.1622776601683795}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 58}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 7}}}}}, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}, "l": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 3}}}}, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 8}}}, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 9, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}}, "df": 1}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}}, "df": 2}}}}}}}}}, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 3}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3}, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.23606797749979}}, "df": 5}}}}, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}, "c": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 2}}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}, "a": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}}, "l": {"1": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1.4142135623730951}}, "df": 3}, "2": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1.4142135623730951}}, "df": 4}, "docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 3}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1.4142135623730951}}, "df": 14}}, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 2}}, "y": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}, "r": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 1}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}, "m": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 13}}}}, "r": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 2}}}, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}}, "df": 1}}}, "b": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 3, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 1}}, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}}, "df": 1}}}}}, "m": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}}, "df": 3}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 3, "s": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}}, "df": 5, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 2}}, "df": 3, ":": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 9, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}}, "s": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}}, "df": 1}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 1}}}}, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "k": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 14}}, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 16, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 3}}}}}}}}}}}}}}}}}}}}}}}, "[": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 3}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 3}}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3}}, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "[": {"5": {"1": {"4": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {}, "df": 0}}}}}}}, "e": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.23606797749979}}, "df": 2}}}, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 14}}}}, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}}, "df": 11}}, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 4}}, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "o": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 8}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 5}}, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 4, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 2}}}}}}}, "w": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 9, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 3}}, "r": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.7320508075688772}}, "df": 7}}, "p": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 5}}}}}, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 3}}}}}}}}, "a": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 7, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.from_file": {"tf": 1}}, "df": 1}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}}, "df": 1}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 1}}}}, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.4142135623730951}}, "df": 3}}, "g": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 2}}, "u": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 8.12403840463596}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1.4142135623730951}}, "df": 79, "r": {"docs": {"ramanchada2": {"tf": 2.6457513110645907}, "ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 7}, "d": {"docs": {"ramanchada2": {"tf": 4.58257569495584}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 2}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 2}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 2}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 2}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 2}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 2}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 2}}, "df": 38}, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 4}, "f": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 3.605551275463989}, "ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}}, "df": 43}}}, "a": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 16}}}}, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 3}}}}}}}}, "h": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}}, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 3.3166247903554}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 15}}}}, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1, "y": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 2.449489742783178}}, "df": 3}, "s": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}}, "df": 1}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}, "s": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}}}}}}}}, "d": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 8}}}}}}}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "k": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.7320508075688772}}, "df": 7}}}, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 7}}}}}}, "r": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}}, "n": {"0": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1}, "1": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1}, "2": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2": {"tf": 3.605551275463989}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}}, "df": 19, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}}, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}}}, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.4142135623730951}}, "df": 3}}}}, "m": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 15, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel.model_computed_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_fields": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_fields": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema.model_computed_fields": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds.model_computed_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_fields": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds.model_computed_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_fields": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel.model_computed_fields": {"tf": 1}}, "df": 28, "p": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.4142135623730951}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.4142135623730951}}, "df": 8}}}}}}}, "n": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.23606797749979}}, "df": 2, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 2}}}, "o": {"docs": {"ramanchada2": {"tf": 5}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 14, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 4.242640687119285}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 10}}}, "n": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.io.HSDS.DatasetExistsError": {"tf": 1}, "ramanchada2.io.experimental.rc1_parser.io.UnsupportedFileTypeError": {"tf": 1}, "ramanchada2.misc.exceptions.ApplicationException": {"tf": 1}, "ramanchada2.misc.exceptions.InputParserError": {"tf": 1}, "ramanchada2.misc.exceptions.ChadaReadNotFoundError": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}}, "df": 13, "e": {"docs": {"ramanchada2": {"tf": 5.385164807134504}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 2.23606797749979}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 2}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 3.1622776601683795}}, "df": 23}}, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 3}}, "t": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 15, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 5}}, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}, "r": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 3, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "z": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 2}}, "df": 3, "d": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 9}}}}}}}}}, "e": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2": {"tf": 6.708203932499369}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.filters.add_poisson_noise.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_poisson_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 67, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 3}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1.4142135623730951}}, "df": 4}}, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 3}}}, "t": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "x": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}}, "df": 1}}}, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}}, "df": 3}}}}, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}}, "df": 2}}, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}}}}}}}}}}, "g": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 3.3166247903554}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1.4142135623730951}}, "df": 21, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.filters.dropna.dropna": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.dropna": {"tf": 1}}, "df": 5}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 3, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}}, "df": 2}}}}}}, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}}, "df": 3}}}, "d": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}}, "df": 5}}}}, "m": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 11}, "p": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 4.123105625617661}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.7320508075688772}}, "df": 10, "o": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}}, "df": 2}}}}}}, "d": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}}, "df": 6}}}}}, "i": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}, "b": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.7320508075688772}}, "df": 3}}}}, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}, "c": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"7": {"8": {"5": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}}, "df": 2}, "docs": {}, "df": 0}, "docs": {}, "df": 0}, "docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}}}, "w": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.7320508075688772}}, "df": 1, "a": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 2}, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2.8284271247461903}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1.4142135623730951}}, "df": 9, "l": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.set_laser_wavelength": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}}, "df": 17}}}}}}, "n": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}}, "df": 9}}}}}}}}, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 17}, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 5.744562646538029}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2.23606797749979}, "ramanchada2.protocols.spectraframe.SpectraFrame.validate_columns": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.from_dataframe": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 2.6457513110645907}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 2.23606797749979}}, "df": 44, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1}}, "df": 3}}}}}, "n": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2": {"tf": 4.123105625617661}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.baseline.moving_minimum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average": {"tf": 1}, "ramanchada2.spectrum.filters.moving_average.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.moving_median.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_minimum": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_average_convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.subtract_moving_median": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1}}, "df": 27}}}}, "d": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 2.23606797749979}, "ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.derivative_sharpening": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.7320508075688772}}, "df": 9, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3}}}, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 3, "r": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 5.5677643628300215}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2}}, "df": 37}}, "k": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "v": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 5, "l": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 2}}, "i": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1.4142135623730951}}, "df": 1, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 4}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 2}}}}}, "a": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.fit_peaks_result.FitPeaksResult": {"tf": 1}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}}, "df": 1}}}}}}}, "h": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}}, "c": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.spike_indices": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.spike_indices": {"tf": 1}}, "df": 10}}}, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.6457513110645907}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 6}, "r": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 6}}, "t": {"docs": {}, "df": 0, "h": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1.7320508075688772}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1.7320508075688772}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1.7320508075688772}}, "df": 16}}}}}, "o": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}, "l": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}, "ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 4, "e": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.7320508075688772}}, "df": 5}}}, "d": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "k": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 4}}, "u": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}}, "x": {"docs": {"ramanchada2": {"tf": 8}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 2}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.derive_model_x": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 3}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 3.3166247903554}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 4}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 2}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.change_x_units.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 2}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 2}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.creators.from_spectral_component_collection.from_spectral_component_collection": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_theoretical_lines.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 2.449489742783178}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.trim_axes.trim_axes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.peaks.find_peaks_BayesianGaussianMixture.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.abs_nm_to_shift_cm_1_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.shift_cm_1_to_abs_nm_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_fun": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_spectral_component_collection": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_theoretical_lines": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.trim_axes": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 2.23606797749979}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 2}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.spectrum.Spectrum.bayesian_gaussian_mixture": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1}}, "df": 60, "*": {"docs": {}, "df": 0, "*": {"2": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 4}, "3": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}, "4": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}, "5": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}, "/": {"5": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 3}, "docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 3}}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2": {"tf": 2.449489742783178}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.7320508075688772}}, "df": 3, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 1}}}}}}}}}}, "a": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 2.6457513110645907}, "ramanchada2.spectrum.calibration.set_new_xaxis.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.spectrum.Spectrum.set_new_xaxis": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1.7320508075688772}}, "df": 5}}}}, "x": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "y": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "z": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}}, "df": 9}}}, "o": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2.23606797749979}}, "df": 1}}}, "g": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}}, "df": 1}}}}, "f": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}, "[": {"0": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0, "i": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.7320508075688772}}, "df": 1, "+": {"1": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}}}, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 4}}, "df": 1}, "l": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "m": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}}, "y": {"docs": {"ramanchada2": {"tf": 4.898979485566356}, "ramanchada2.misc.utils.argmin2d.align": {"tf": 1.7320508075688772}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 3.872983346207417}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2.8284271247461903}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 5.196152422706632}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical.__init__": {"tf": 1}, "ramanchada2.spectrum.calibration.normalize.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_xaxis.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.calibration.scale_yaxis.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.drop_spikes.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.drop_spikes.get_spikes": {"tf": 1}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.filters.resampling.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.resampling.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_yaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.normalize": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.scale_xaxis_linear": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.drop_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.recover_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.get_spikes": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_NUDFT_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.resample_spline_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}}, "df": 36, "y": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "z": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}, "a": {"docs": {}, "df": 0, "x": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "o": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}}, "df": 1}}, "u": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}}, "df": 2}}, "f": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}, "g": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}, "[": {"0": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}, "docs": {}, "df": 0}, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}}, "df": 1, "i": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "f": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 2}}}}}}}}}}, "o": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 1}}}}}}}}}}}}, "e": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}}, "df": 1}}}}}}}}}, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "h": {"5": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "d": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}, "docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 2.449489742783178}}, "df": 1, "a": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.7320508075688772}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 13}, "v": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1}}, "df": 8}}, "l": {"docs": {}, "df": 0, "f": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel.lwhm": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakModel.rwhm": {"tf": 1}}, "df": 2}, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1}}}}, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}}}, "i": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}}}}}, "g": {"docs": {}, "df": 0, "h": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.utils.matchsets.cost_function": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.calibrate_by_deltas_model": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.calibrate_by_deltas_model": {"tf": 1}}, "df": 4}}}}, "l": {"docs": {}, "df": 0, "b": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.4142135623730951}}, "df": 5}}}}}}, "d": {"docs": {}, "df": 0, "f": {"5": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1}, "docs": {"ramanchada2": {"tf": 1}}, "df": 1}, "r": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.hdr_from_multi_exposure.hdr_from_multi_exposure": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hdr_from_multi_exposure": {"tf": 1}}, "df": 3}}, "h": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2": {"tf": 3}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 2.449489742783178}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 2.449489742783178}}, "df": 5}}, "u": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1.4142135623730951}}, "df": 5}}}}, "o": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}, "ramanchada2.spectrum.filters.sharpen_lines.hht_sharpening_chain": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.hht_sharpening_chain": {"tf": 1}}, "df": 4}, "l": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1.4142135623730951}}, "df": 1, "s": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 1}}}, "m": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}}}}}, "t": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, ":": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "/": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "i": {"docs": {"ramanchada2.io.simulated.vasp.vasp_simulation_dat.lines_from_vasp_dat": {"tf": 1}}, "df": 1}, "c": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.misc.types.peak_candidates.PeakModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.PeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.peak_candidates.ListPeakCandidateMultiModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydBaseModel": {"tf": 1}, "ramanchada2.misc.types.pydantic_base_model.PydRootModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.applied_processings.SpeProcessingListModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataFieldModel": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}, "ramanchada2.protocols.spectraframe.SpectraFrameSchema": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.ParamBounds": {"tf": 1}, "ramanchada2.spectrum.calibration.by_deltas.FitBounds": {"tf": 1}, "ramanchada2.theoretical_lines.model_from_lines.PydPeakModel": {"tf": 1}}, "df": 14}}}}, "t": {"docs": {}, "df": 0, "s": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 1}}, "df": 1}}}}}}, "w": {"docs": {}, "df": 0, "w": {"docs": {}, "df": 0, "w": {"docs": {"ramanchada2.protocols.twinning.TwinningComponent": {"tf": 1}}, "df": 1}}}}}}}}}, "m": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1}}, "df": 1}}}, "e": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "p": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {"ramanchada2.misc.plottable.Plottable": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_component.CalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.XCalibrationComponent": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.LazerZeroingComponent": {"tf": 1}, "ramanchada2.spectral_components.baseline.baseline_base.BaseLineBase": {"tf": 1}, "ramanchada2.spectral_components.baseline.numerical.BaselineNumerical": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.delta.DeltasPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.gauss.GaussPeak": {"tf": 1}, "ramanchada2.spectral_components.peak_profile.voigt.VoigtPeak": {"tf": 1}, "ramanchada2.spectral_components.spectral_component.SpectralComponent": {"tf": 1}, "ramanchada2.spectral_components.spectral_component_collection.SpectralComponentCollection": {"tf": 1}, "ramanchada2.spectral_components.spectral_peak.SpectralPeak": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum": {"tf": 1}}, "df": 14}}}}, "r": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "e": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}}}, "t": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 1}}, "df": 1}}}}}}}}}}}, "x": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.spectraframe.SpectraFrame.multiply": {"tf": 1.7320508075688772}}, "df": 1}}}}}}}, "k": {"docs": {"ramanchada2.io.experimental.rc1_parser.binary_readers.readSPA": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 4.358898943540674}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1}}, "df": 4, "e": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2": {"tf": 1}}, "df": 1, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1}}, "df": 3}}}}}, "y": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1}}, "df": 5, "w": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "d": {"docs": {"ramanchada2": {"tf": 1.7320508075688772}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}}, "df": 5, "s": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}}, "df": 1}}}}}, "s": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.misc.types.spectrum.metadata.SpeMetadataModel.get_all_keys": {"tf": 1}, "ramanchada2.misc.utils.matchsets.match_peaks": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_delta_lines.from_delta_lines": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_delta_lines": {"tf": 1}}, "df": 5}}, "r": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "l": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}}, "df": 1}}}}}, "w": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.get_fitted_peaks.fit_peak_positions": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peak_positions": {"tf": 1.4142135623730951}}, "df": 5, "a": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "g": {"docs": {}, "df": 0, "s": {"docs": {"ramanchada2": {"tf": 3.1622776601683795}, "ramanchada2.spectrum.calibration.by_deltas.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.creators.from_cache_or_calc.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.creators.from_test_spe.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.filters.convolve.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.smoothing.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.peaks.find_peaks.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.peaks.fit_peaks.fit_peaks_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.xcal_fine_RBF": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_cache_or_calc": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_test_spe": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.convolve": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.smoothing_RC1": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.find_peak_multipeak_filter": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.fit_peaks_filter": {"tf": 1}}, "df": 17}}}}}, "+": {"1": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}}, "df": 1}, "docs": {}, "df": 0}, "n": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 2}}, "df": 1}}}}, "z": {"docs": {}, "df": 0, "e": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "o": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.baseline.add_baseline.add_baseline": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.add_baseline": {"tf": 1}}, "df": 5, "s": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.pad_zeros.pad_zeros": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.pad_zeros": {"tf": 1}}, "df": 3}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "g": {"docs": {"ramanchada2.protocols.calib_ne_si_argmin2d_iter_gg.silicon_calibration": {"tf": 1}}, "df": 1}}}}}}, "z": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.creators.from_simulation.from_simulation": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.from_simulation": {"tf": 1.4142135623730951}}, "df": 3}}, "j": {"docs": {"ramanchada2": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.filters.add_gaussian_noise_drift.add_gaussian_noise_drift": {"tf": 1.4142135623730951}, "ramanchada2.spectrum.spectrum.Spectrum.add_gaussian_noise_drift": {"tf": 1.4142135623730951}}, "df": 5, "d": {"docs": {}, "df": 0, "x": {"docs": {"ramanchada2": {"tf": 1}, "ramanchada2.spectrum.creators.from_local_file.from_local_file": {"tf": 1}, "ramanchada2.spectrum.spectrum.Spectrum.from_local_file": {"tf": 1}}, "df": 3}}, "u": {"docs": {}, "df": 0, "m": {"docs": {}, "df": 0, "p": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator": {"tf": 1}}, "df": 1}}}, "s": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "n": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.save_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.xcalibration.CustomPChipInterpolator.load_coefficients": {"tf": 1}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 1}}, "df": 3}}}}, "q": {"docs": {}, "df": 0, "u": {"docs": {}, "df": 0, "o": {"docs": {}, "df": 0, "t": {"docs": {"ramanchada2.protocols.calibration.calibration_model.CalibrationModel.__init__": {"tf": 2.449489742783178}, "ramanchada2.protocols.calibration.xcalibration.CustomCubicSplineInterpolator": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationCertificate": {"tf": 3.1622776601683795}, "ramanchada2.protocols.calibration.ycalibration.CertificatesDict": {"tf": 2}, "ramanchada2.protocols.calibration.ycalibration.YCalibrationComponent": {"tf": 2.449489742783178}, "ramanchada2.protocols.spectraframe.SpectraFrame": {"tf": 6.324555320336759}}, "df": 6}}, "i": {"docs": {}, "df": 0, "n": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 2}}, "df": 1}}}}}, "a": {"docs": {}, "df": 0, "d": {"docs": {}, "df": 0, "r": {"docs": {}, "df": 0, "a": {"docs": {}, "df": 0, "t": {"docs": {}, "df": 0, "i": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1.4142135623730951}}, "df": 1, "a": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "l": {"docs": {}, "df": 0, "y": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}}}}}}}, "m": {"docs": {}, "df": 0, "c": {"docs": {"ramanchada2.protocols.calibration.xcalibration.CustomRBFInterpolator": {"tf": 1}}, "df": 1}}}}}}, "pipeline": ["trimmer"], "_isPrebuiltIndex": true};
+
+ // mirrored in build-search-index.js (part 1)
+ // Also split on html tags. this is a cheap heuristic, but good enough.
+ elasticlunr.tokenizer.setSeperator(/[\s\-.;&_'"=,()]+|<[^>]*>/);
+
+ let searchIndex;
+ if (docs._isPrebuiltIndex) {
+ console.info("using precompiled search index");
+ searchIndex = elasticlunr.Index.load(docs);
+ } else {
+ console.time("building search index");
+ // mirrored in build-search-index.js (part 2)
+ searchIndex = elasticlunr(function () {
+ this.pipeline.remove(elasticlunr.stemmer);
+ this.pipeline.remove(elasticlunr.stopWordFilter);
+ this.addField("qualname");
+ this.addField("fullname");
+ this.addField("annotation");
+ this.addField("default_value");
+ this.addField("signature");
+ this.addField("bases");
+ this.addField("doc");
+ this.setRef("fullname");
+ });
+ for (let doc of docs) {
+ searchIndex.addDoc(doc);
+ }
+ console.timeEnd("building search index");
+ }
+
+ return (term) => searchIndex.search(term, {
+ fields: {
+ qualname: {boost: 4},
+ fullname: {boost: 2},
+ annotation: {boost: 2},
+ default_value: {boost: 2},
+ signature: {boost: 2},
+ bases: {boost: 2},
+ doc: {boost: 1},
+ },
+ expand: true
+ });
+})();
\ No newline at end of file