From 00f80aef211dc9d927a23a2b56d663a1d82850ee Mon Sep 17 00:00:00 2001 From: DLS Jenkins Date: Mon, 24 Jun 2024 23:21:18 +0100 Subject: [PATCH] htdocs update (master) --- .../dials/algorithms/indexing/indexer.html | 36 +- .../dials/algorithms/indexing/max_cell.html | 2 + .../algorithms/indexing/model_evaluation.html | 4 +- .../algorithms/indexing/nearest_neighbor.html | 18 +- .../dials/algorithms/refinement/refiner.html | 21 +- .../refinement/reflection_manager.html | 585 ++++++++++++++++-- .../dials/algorithms/refinement/target.html | 200 +++++- .../refinement/weighting_strategies.html | 64 ++ .../algorithms/dials.algorithms.indexing.html | 6 +- .../dials.algorithms.refinement.html | 150 +++++ .../library_reference/algorithms/index.html | 6 + documentation/programs/dials_index.html | 4 + documentation/programs/dials_refine.html | 4 + .../dials_refine_bravais_settings.html | 4 + genindex.html | 94 ++- searchindex.js | 2 +- 16 files changed, 1105 insertions(+), 95 deletions(-) diff --git a/_modules/dials/algorithms/indexing/indexer.html b/_modules/dials/algorithms/indexing/indexer.html index 8797c5721..d32276e86 100644 --- a/_modules/dials/algorithms/indexing/indexer.html +++ b/_modules/dials/algorithms/indexing/indexer.html @@ -52,7 +52,7 @@

Source code for dials.algorithms.indexing.indexer

import iotbx.phil import libtbx from cctbx import sgtbx -from dxtbx.model import ExperimentList, ImageSequence +from dxtbx.model import ExperimentList, ImageSequence, tof_helpers import dials.util from dials.algorithms.indexing import ( @@ -931,7 +931,7 @@

Source code for dials.algorithms.indexing.indexer

refined_reflections = reflections.select(imgset_sel) panel_numbers = flex.size_t(refined_reflections["panel"]) xyzcal_mm = refined_reflections["xyzcal.mm"] - x_mm, y_mm, z_rad = xyzcal_mm.parts() + x_mm, y_mm, z = xyzcal_mm.parts() xy_cal_mm = flex.vec2_double(x_mm, y_mm) xy_cal_px = flex.vec2_double(len(xy_cal_mm)) for i_panel in range(len(expt.detector)): @@ -942,10 +942,18 @@

Source code for dials.algorithms.indexing.indexer

) x_px, y_px = xy_cal_px.parts() if expt.scan is not None: - z_px = expt.scan.get_array_index_from_angle(z_rad, deg=False) + if expt.scan.has_property("time_of_flight"): + tof = expt.scan.get_property("time_of_flight") + frames = list(range(len(tof))) + tof_to_frame = tof_helpers.tof_to_frame_interpolator(tof, frames) + z.set_selected(z < min(tof), min(tof)) + z.set_selected(z > max(tof), max(tof)) + z_px = flex.double(tof_to_frame(z)) + else: + z_px = expt.scan.get_array_index_from_angle(z, deg=False) else: # must be a still image, z centroid not meaningful - z_px = z_rad + z_px = z xyzcal_px = flex.vec3_double(x_px, y_px, z_px) reflections["xyzcal.px"].set_selected(imgset_sel, xyzcal_px) @@ -1004,6 +1012,25 @@

Source code for dials.algorithms.indexing.indexer

self.params.max_cell = params.multiplier * max(uc_params[:3]) logger.info("Using max_cell: %.1f Angstrom", self.params.max_cell) else: + + convert_reflections_z_to_deg = True + all_tof_experiments = False + for expt in self.experiments: + if expt.scan is not None and expt.scan.has_property( + "time_of_flight" + ): + all_tof_experiments = True + elif all_tof_experiments: + raise ValueError( + "Cannot find max cell for ToF and non-ToF experiments at the same time" + ) + + if all_tof_experiments: + if params.step_size < 100: + logger.info("Setting default ToF step size to 500 usec") + params.step_size = 500 + convert_reflections_z_to_deg = False + self.params.max_cell = find_max_cell( self.reflections, max_cell_multiplier=params.multiplier, @@ -1015,6 +1042,7 @@

Source code for dials.algorithms.indexing.indexer

filter_ice=params.filter_ice, filter_overlaps=params.filter_overlaps, overlaps_border=params.overlaps_border, + convert_reflections_z_to_deg=convert_reflections_z_to_deg, ).max_cell logger.info("Found max_cell: %.1f Angstrom", self.params.max_cell)
diff --git a/_modules/dials/algorithms/indexing/max_cell.html b/_modules/dials/algorithms/indexing/max_cell.html index bc5cf8440..34f13672a 100644 --- a/_modules/dials/algorithms/indexing/max_cell.html +++ b/_modules/dials/algorithms/indexing/max_cell.html @@ -68,6 +68,7 @@

Source code for dials.algorithms.indexing.max_cell

filter_ice=True, filter_overlaps=True, overlaps_border=0, + convert_reflections_z_to_deg=True, ): logger.debug("Finding suitable max_cell based on %i reflections", len(reflections)) # Exclude potential ice-ring spots from nearest neighbour analysis if needed @@ -109,6 +110,7 @@

Source code for dials.algorithms.indexing.max_cell

percentile=nearest_neighbor_percentile, histogram_binning=histogram_binning, nn_per_bin=nn_per_bin, + convert_reflections_z_to_deg=convert_reflections_z_to_deg, ) except AssertionError as e: raise DialsIndexError("Failure in nearest neighbour analysis:\n" + str(e)) diff --git a/_modules/dials/algorithms/indexing/model_evaluation.html b/_modules/dials/algorithms/indexing/model_evaluation.html index d99031ec9..176556999 100644 --- a/_modules/dials/algorithms/indexing/model_evaluation.html +++ b/_modules/dials/algorithms/indexing/model_evaluation.html @@ -322,7 +322,7 @@

Source code for dials.algorithms.indexing.model_evaluation

def score_by_rmsd_xy(self, reverse=False): # smaller rmsds = better rmsd_x, rmsd_y, rmsd_z = flex.vec3_double( - s.rmsds for s in self.all_solutions + s.rmsds[:3] for s in self.all_solutions ).parts() rmsd_xy = flex.sqrt(flex.pow2(rmsd_x) + flex.pow2(rmsd_y)) score = flex.log(rmsd_xy) / math.log(2) @@ -384,7 +384,7 @@

Source code for dials.algorithms.indexing.model_evaluation

perm = flex.sort_permutation(combined_scores) rmsd_x, rmsd_y, rmsd_z = flex.vec3_double( - s.rmsds for s in self.all_solutions + s.rmsds[:3] for s in self.all_solutions ).parts() rmsd_xy = flex.sqrt(flex.pow2(rmsd_x) + flex.pow2(rmsd_y)) diff --git a/_modules/dials/algorithms/indexing/nearest_neighbor.html b/_modules/dials/algorithms/indexing/nearest_neighbor.html index 6ff491238..7809a798f 100644 --- a/_modules/dials/algorithms/indexing/nearest_neighbor.html +++ b/_modules/dials/algorithms/indexing/nearest_neighbor.html @@ -61,6 +61,7 @@

Source code for dials.algorithms.indexing.nearest_neighbor

percentile=None, histogram_binning="linear", nn_per_bin=5, + convert_reflections_z_to_deg=True, ): self.tolerance = tolerance # Margin of error for max unit cell estimate from scitbx.array_family import flex @@ -76,7 +77,10 @@

Source code for dials.algorithms.indexing.nearest_neighbor

else: entering_flags = flex.bool(reflections.size(), True) rs_vectors = reflections["rlp"] - phi_deg = reflections["xyzobs.mm.value"].parts()[2] * (180 / math.pi) + + z = reflections["xyzobs.mm.value"].parts()[2] + if convert_reflections_z_to_deg: + z = z * (180 / math.pi) d_spacings = flex.double() # nearest neighbor analysis @@ -86,16 +90,16 @@

Source code for dials.algorithms.indexing.nearest_neighbor

sel_imageset = reflections["imageset_id"] == imageset_id if sel_imageset.count(True) == 0: continue - phi_min = flex.min(phi_deg.select(sel_imageset)) - phi_max = flex.max(phi_deg.select(sel_imageset)) - d_phi = phi_max - phi_min - n_steps = max(int(math.ceil(d_phi / step_size)), 1) + z_min = flex.min(z.select(sel_imageset)) + z_max = flex.max(z.select(sel_imageset)) + d_z = z_max - z_min + n_steps = max(int(math.ceil(d_z / step_size)), 1) for n in range(n_steps): sel_step = ( sel_imageset - & (phi_deg >= (phi_min + n * step_size)) - & (phi_deg < (phi_min + (n + 1) * step_size)) + & (z >= (z_min + n * step_size)) + & (z < (z_min + (n + 1) * step_size)) ) for entering in (True, False): diff --git a/_modules/dials/algorithms/refinement/refiner.html b/_modules/dials/algorithms/refinement/refiner.html index 5479550de..ae537a119 100644 --- a/_modules/dials/algorithms/refinement/refiner.html +++ b/_modules/dials/algorithms/refinement/refiner.html @@ -290,6 +290,9 @@

Source code for dials.algorithms.refinement.refiner

"flags", "shoebox", "delpsical.weights", + "wavelength", + "wavelength_cal", + "s0", ] # NB xyzobs.px.value & xyzcal.px required by SauterPoon outlier rejector # NB delpsical.weights is used by ExternalDelPsiWeightingStrategy @@ -435,6 +438,7 @@

Source code for dials.algorithms.refinement.refiner

obs["x_resid"] = x_calc - x_obs obs["y_resid"] = y_calc - y_obs obs["phi_resid"] = phi_calc - phi_obs + refman.update_residuals() # determine whether to do basic centroid analysis to automatically # determine outlier rejection block @@ -925,6 +929,9 @@

Source code for dials.algorithms.refinement.refiner

if units == "mm": header.append(name + "\n(mm)") rmsd_multipliers.append(1.0) + elif units == "A": + header.append(name + "\n(A)") + rmsd_multipliers.append(1.0) elif units == "rad": # convert radians to degrees for reporting header.append(name + "\n(deg)") rmsd_multipliers.append(RAD2DEG) @@ -1006,6 +1013,8 @@

Source code for dials.algorithms.refinement.refiner

# will convert other angles in radians to degrees (e.g. for # RMSD_DeltaPsi and RMSD_2theta) header.append(name + "\n(deg)") + elif name == "RMSD_wavelength" and units == "frame": + header.append(name + "\n(frame)") else: # skip other/unknown RMSDs pass @@ -1027,7 +1036,7 @@

Source code for dials.algorithms.refinement.refiner

scan = exp.scan try: images_per_rad = 1.0 / abs(scan.get_oscillation(deg=False)[1]) - except (AttributeError, ZeroDivisionError): + except (AttributeError, ZeroDivisionError, RuntimeError): images_per_rad = None raw_rmsds = self._target.rmsds_for_experiment(iexp) @@ -1044,6 +1053,8 @@

Source code for dials.algorithms.refinement.refiner

rmsds.append(rmsd * px_per_mm[1]) elif name == "RMSD_Phi" and units == "rad": rmsds.append(rmsd * images_per_rad) + elif name == "RMSD_wavelength" and units == "frame": + rmsds.append(rmsd) elif units == "rad": rmsds.append(rmsd * RAD2DEG) rows.append([str(iexp), str(num)] + [f"{r:.5g}" for r in rmsds]) @@ -1072,14 +1083,14 @@

Source code for dials.algorithms.refinement.refiner

def print_panel_rmsd_table(self): """print useful output about refinement steps in the form of a simple table""" - if len(self._experiments.scans()) > 1: + if len(self._experiments.scans()) > 1 and not self._experiments.all_tof(): logger.warning( "Multiple scans present. Only the first scan will be used " "to determine the image width for reporting RMSDs" ) scan = self._experiments.scans()[0] images_per_rad = None - if scan: + if scan and scan.has_property("oscillation"): if scan.get_oscillation(deg=False)[1] != 0.0: images_per_rad = 1.0 / abs(scan.get_oscillation(deg=False)[1]) @@ -1100,6 +1111,8 @@

Source code for dials.algorithms.refinement.refiner

name == "RMSD_DeltaPsi" and units == "rad" ): # convert radians to degrees for reporting of stills header.append(name + "\n(deg)") + elif name == "RMSD_wavelength" and units == "frame": + header.append(name + "\n(frame)") else: # skip RMSDs that cannot be expressed in image/scan space pass @@ -1126,6 +1139,8 @@

Source code for dials.algorithms.refinement.refiner

rmsds.append(rmsd * images_per_rad) elif name == "RMSD_DeltaPsi" and units == "rad": rmsds.append(rmsd * RAD2DEG) + elif name == "RMSD_wavelength" and units == "frame": + rmsds.append(rmsd) rows.append([str(ipanel), str(num)] + [f"{r:.5g}" for r in rmsds]) if len(rows) > 0: diff --git a/_modules/dials/algorithms/refinement/reflection_manager.html b/_modules/dials/algorithms/refinement/reflection_manager.html index c32357460..578b10be1 100644 --- a/_modules/dials/algorithms/refinement/reflection_manager.html +++ b/_modules/dials/algorithms/refinement/reflection_manager.html @@ -52,6 +52,8 @@

Source code for dials.algorithms.refinement.reflection_manager

import random import libtbx +from dxtbx.model import tof_helpers +from dxtbx.model.experiment_list import ExperimentList from libtbx.phil import parse from scitbx import matrix from scitbx.math import five_number_summary @@ -146,6 +148,10 @@

Source code for dials.algorithms.refinement.reflection_manager

"whether the case is for stills or scans. The default gives" "unit weighting." .type = floats(size = 3, value_min = 0) + wavelength_weight = 1e4 + .help = "Weight for the wavelength term in the target function for" + "Laue refinement" + .type = float(value_min = 0) } %(outlier_phil)s @@ -288,32 +294,99 @@

Source code for dials.algorithms.refinement.reflection_manager

flex.set_random_seed(params.random_seed) logger.debug("Random seed set to %d", params.random_seed) - # check whether we deal with stills or scans - if do_stills: - refman = StillsReflectionManager - # check incompatible weighting strategy - if params.weighting_strategy.override == "statistical": - raise DialsRefineConfigError( - 'The "statistical" weighting strategy is not compatible ' - "with stills refinement" - ) + if "wavelength" in reflections: + return ReflectionManagerFactory.laue_manager( + experiments, reflections, params + ) + + elif do_stills: + return ReflectionManagerFactory.stills_manager( + experiments, reflections, params + ) + else: - refman = ReflectionManager - # check incompatible weighting strategy - if params.weighting_strategy.override in ["stills", "external_deltapsi"]: - msg = ( - 'The "{}" weighting strategy is not compatible with ' - "scan refinement" - ).format(params.weighting_strategy.override) - raise DialsRefineConfigError(msg) - - # set automatic outlier rejection options + return ReflectionManagerFactory.rotation_scan_manager( + experiments, reflections, params + )
+ + +
+[docs] + @staticmethod + def stills_manager( + experiments: ExperimentList, + reflections: flex.reflection_table, + params: libtbx.phil.scope_extract, + ) -> StillsReflectionManager: + + refman = StillsReflectionManager + + ## Outlier detection + if params.outlier.algorithm in ("auto", libtbx.Auto): - if do_stills: - params.outlier.algorithm = "sauter_poon" - else: - params.outlier.algorithm = "mcd" + params.outlier.algorithm = "sauter_poon" + if params.outlier.sauter_poon.px_sz is libtbx.Auto: + # get this from the first panel of the first detector + params.outlier.sauter_poon.px_sz = experiments.detectors()[0][ + 0 + ].get_pixel_size() + if params.outlier.algorithm in ("null", None): + outlier_detector = None + else: + colnames = ["x_resid", "y_resid"] + params.outlier.block_width = None + from dials.algorithms.refinement.outlier_detection import ( + CentroidOutlierFactory, + ) + + outlier_detector = CentroidOutlierFactory.from_parameters_and_colnames( + params, colnames + ) + + ## Weighting strategy + + # check incompatible weighting strategy + if params.weighting_strategy.override == "statistical": + raise DialsRefineConfigError( + 'The "statistical" weighting strategy is not compatible ' + "with stills refinement" + ) + if params.weighting_strategy.override == "constant": + params.weighting_strategy.override = "constant_stills" + + weighting_strategy = ReflectionManagerFactory.get_weighting_strategy_override( + params + ) + + return refman( + reflections=reflections, + experiments=experiments, + nref_per_degree=params.reflections_per_degree, + max_sample_size=params.maximum_sample_size, + min_sample_size=params.minimum_sample_size, + close_to_spindle_cutoff=params.close_to_spindle_cutoff, + scan_margin=params.scan_margin, + outlier_detector=outlier_detector, + weighting_strategy_override=weighting_strategy, + )
+ + +
+[docs] + @staticmethod + def rotation_scan_manager( + experiments: ExperimentList, + reflections: flex.reflection_table, + params: libtbx.phil.scope_extract, + ) -> ReflectionManager: + + refman = ReflectionManager + + ## Outlier detection + + if params.outlier.algorithm in ("auto", libtbx.Auto): + params.outlier.algorithm = "mcd" if params.outlier.algorithm == "sauter_poon": if params.outlier.sauter_poon.px_sz is libtbx.Auto: # get this from the first panel of the first detector @@ -321,15 +394,19 @@

Source code for dials.algorithms.refinement.reflection_manager

0 ].get_pixel_size() - # do outlier rejection? + ## Weighting strategy + + # check incompatible weighting strategy + if params.weighting_strategy.override in ["stills", "external_deltapsi"]: + msg = ( + 'The "{}" weighting strategy is not compatible with ' "scan refinement" + ).format(params.weighting_strategy.override) + raise DialsRefineConfigError(msg) + if params.outlier.algorithm in ("null", None): outlier_detector = None else: - if do_stills: - colnames = ["x_resid", "y_resid"] - params.outlier.block_width = None - else: - colnames = ["x_resid", "y_resid", "phi_resid"] + colnames = ["x_resid", "y_resid", "phi_resid"] from dials.algorithms.refinement.outlier_detection import ( CentroidOutlierFactory, ) @@ -338,36 +415,87 @@

Source code for dials.algorithms.refinement.reflection_manager

params, colnames ) - # override default weighting strategy? - weighting_strategy = None - if params.weighting_strategy.override == "statistical": - from dials.algorithms.refinement.weighting_strategies import ( - StatisticalWeightingStrategy, - ) + weighting_strategy = ReflectionManagerFactory.get_weighting_strategy_override( + params + ) - weighting_strategy = StatisticalWeightingStrategy() - elif params.weighting_strategy.override == "stills": - from dials.algorithms.refinement.weighting_strategies import ( - StillsWeightingStrategy, - ) + return refman( + reflections=reflections, + experiments=experiments, + nref_per_degree=params.reflections_per_degree, + max_sample_size=params.maximum_sample_size, + min_sample_size=params.minimum_sample_size, + close_to_spindle_cutoff=params.close_to_spindle_cutoff, + scan_margin=params.scan_margin, + outlier_detector=outlier_detector, + weighting_strategy_override=weighting_strategy, + )
- weighting_strategy = StillsWeightingStrategy( - params.weighting_strategy.delpsi_constant + +
+[docs] + @staticmethod + def laue_manager( + experiments: ExperimentList, + reflections: flex.reflection_table, + params: libtbx.phil.scope_extract, + ) -> LaueReflectionManager: + + all_tof_experiments = False + for expt in experiments: + if expt.scan is not None and expt.scan.has_property("time_of_flight"): + all_tof_experiments = True + elif all_tof_experiments: + raise ValueError( + "Cannot refine ToF and non-ToF experiments at the same time" + ) + + if all_tof_experiments: + refman = TOFReflectionManager + else: + refman = LaueReflectionManager + + ## Outlier detection + if params.outlier.algorithm in ("auto", libtbx.Auto): + params.outlier.algorithm = "mcd" + if params.outlier.sauter_poon.px_sz is libtbx.Auto: + # get this from the first panel of the first detector + params.outlier.sauter_poon.px_sz = experiments.detectors()[0][ + 0 + ].get_pixel_size() + + if params.outlier.algorithm in ("null", None): + outlier_detector = None + else: + colnames = ["x_resid", "y_resid"] + params.outlier.block_width = None + from dials.algorithms.refinement.outlier_detection import ( + CentroidOutlierFactory, ) - elif params.weighting_strategy.override == "external_deltapsi": - from dials.algorithms.refinement.weighting_strategies import ( - ExternalDelPsiWeightingStrategy, + + outlier_detector = CentroidOutlierFactory.from_parameters_and_colnames( + params, colnames ) - weighting_strategy = ExternalDelPsiWeightingStrategy() + ## Weighting strategy + + if params.weighting_strategy.override == "statistical": + params.weighting_strategy.override = "statistical_laue" elif params.weighting_strategy.override == "constant": - from dials.algorithms.refinement.weighting_strategies import ( - ConstantWeightingStrategy, - ) + params.weighting_strategy.override = "constant_laue" + + if params.weighting_strategy.override is not None: + if params.weighting_strategy.override not in [ + "constant_laue", + "statistical_laue", + ]: + raise ValueError( + f"{params.weighting_strategy.override} not compatible with Laue data" + ) - weighting_strategy = ConstantWeightingStrategy( - *params.weighting_strategy.constants, stills=do_stills - ) + weighting_strategy = ReflectionManagerFactory.get_weighting_strategy_override( + params + ) return refman( reflections=reflections, @@ -379,7 +507,49 @@

Source code for dials.algorithms.refinement.reflection_manager

scan_margin=params.scan_margin, outlier_detector=outlier_detector, weighting_strategy_override=weighting_strategy, + wavelength_weight=params.weighting_strategy.wavelength_weight, )
+ + +
+[docs] + @staticmethod + def get_weighting_strategy_override( + params: libtbx.phil.scope_extract, + ) -> weighting_strategies.StatisticalWeightingStrategy | weighting_strategies.ConstantWeightingStrategy: + + if params.weighting_strategy.override == "statistical": + return weighting_strategies.StatisticalWeightingStrategy() + + elif params.weighting_strategy.override == "stills": + return weighting_strategies.StillsWeightingStrategy( + params.weighting_strategy.delpsi_constant + ) + + elif params.weighting_strategy.override == "external_deltapsi": + return weighting_strategies.ExternalDelPsiWeightingStrategy() + + elif params.weighting_strategy.override == "constant": + return weighting_strategies.ConstantWeightingStrategy( + *params.weighting_strategy.constants + ) + + elif params.weighting_strategy.override == "constant_stills": + return weighting_strategies.ConstantStillsWeightingStrategy( + *params.weighting_strategy.constants + ) + + elif params.weighting_strategy.override == "statistical_laue": + return weighting_strategies.LaueStatisticalWeightingStrategy( + params.weighting_strategy.wavelength_weight, + ) + + elif params.weighting_strategy.override == "constant_laue": + return weighting_strategies.LaueMixedWeightingStrategy( + params.weighting_strategy.wavelength_weight, + ) + + return None
@@ -680,7 +850,11 @@

Source code for dials.algorithms.refinement.reflection_manager

nrefs = sample_size = len(isel) # set sample size according to nref_per_degree (per experiment) - if exp.scan and self._nref_per_degree: + if ( + exp.scan + and exp.scan.has_property("oscillation") + and self._nref_per_degree + ): sequence_range_rad = exp.scan.get_oscillation_range(deg=False) width = abs(sequence_range_rad[1] - sequence_range_rad[0]) * RAD2DEG if self._nref_per_degree is libtbx.Auto: @@ -829,6 +1003,16 @@

Source code for dials.algorithms.refinement.reflection_manager

self._reflections = self._reflections.select(sel) return self._reflections
+ + +
+[docs] + def update_residuals(self): + x_obs, y_obs, phi_obs = self._reflections["xyzobs.mm.value"].parts() + x_calc, y_calc, phi_calc = self._reflections["xyzcal.mm"].parts() + self._reflections["x_resid"] = x_calc - x_obs + self._reflections["y_resid"] = y_calc - y_obs + self._reflections["phi_resid"] = phi_calc - phi_obs
@@ -909,6 +1093,301 @@

Source code for dials.algorithms.refinement.reflection_manager

logger.info(dials.util.tabulate(rows, header) + "\n")
+ + +
+[docs] +class LaueReflectionManager(ReflectionManager): + + _weighting_strategy = weighting_strategies.LaueStatisticalWeightingStrategy() + experiment_type = "laue" + +
+[docs] + def __init__( + self, + reflections, + experiments, + nref_per_degree=None, + max_sample_size=None, + min_sample_size=0, + close_to_spindle_cutoff=0.02, + scan_margin=0.0, + outlier_detector=None, + weighting_strategy_override=None, + wavelength_weight=1e7, + ): + + if len(reflections) == 0: + raise ValueError("Empty reflections table provided to ReflectionManager") + + # keep track of models + self._experiments = experiments + goniometers = [e.goniometer for e in self._experiments] + self._axes = [ + matrix.col(g.get_rotation_axis()) if g else None for g in goniometers + ] + + # unset the refinement flags (creates flags field if needed) + reflections.unset_flags( + flex.size_t_range(len(reflections)), + flex.reflection_table.flags.used_in_refinement, + ) + + # check that the observed beam vectors are stored: if not, compute them + n_s1_set = set_obs_s1(reflections, experiments) + if n_s1_set > 0: + logger.debug("Set scattering vectors for %d reflections", n_s1_set) + + # keep track of the original indices of the reflections + reflections["iobs"] = flex.size_t_range(len(reflections)) + + # Check for monotonically increasing value range. If not, ref_table isn't sorted, + # and proceed to sort by id and panel. This is required for the C++ extension + # modules to allow for nlogn subselection of values used in refinement. + l_id = reflections["id"] + id0 = l_id[0] + for id_x in l_id[1:]: + if id0 <= id_x: + id0 = id_x + else: + reflections.sort("id") # Ensuring the ref_table is sorted by id + reflections.subsort( + "id", "panel" + ) # Ensuring that within each sorted id block, sorting is next performed by panel + break + + # set up the reflection inclusion criteria + self._close_to_spindle_cutoff = close_to_spindle_cutoff # close to spindle + self._scan_margin = DEG2RAD * scan_margin # close to the scan edge + self._outlier_detector = outlier_detector # for outlier rejection + self._nref_per_degree = nref_per_degree # random subsets + self._max_sample_size = max_sample_size # sample size ceiling + self._min_sample_size = min_sample_size # sample size floor + + # exclude reflections that fail some inclusion criteria + refs_to_keep = self._id_refs_to_keep(reflections) + self._accepted_refs_size = len(refs_to_keep) + + # set entering flags for all reflections + reflections.calculate_entering_flags(self._experiments) + + # reset all use flags + self.reset_accepted_reflections(reflections) + + # put full list of indexed reflections aside and select only the reflections + # that were not excluded to manage + self._indexed = reflections + self._reflections = reflections.select(refs_to_keep) + + # set exclusion flag for reflections that failed the tests + refs_to_excl = flex.bool(len(self._indexed), True) + refs_to_excl.set_selected(refs_to_keep, False) + self._indexed.set_flags( + refs_to_excl, self._indexed.flags.excluded_for_refinement + ) + + # set weights for all kept reflections + if weighting_strategy_override is not None: + self._weighting_strategy = weighting_strategy_override + else: + self._weighting_strategy = ( + weighting_strategies.LaueStatisticalWeightingStrategy(wavelength_weight) + ) + self._weighting_strategy.calculate_weights(self._reflections) + + # not known until the manager is finalised + self._sample_size = None
+ + + def _id_refs_to_keep(self, obs_data): + """Create a selection of observations that pass certain conditions. + Stills-specific version removes checks relevant only to experiments + with a rotation axis.""" + + # first exclude reflections with miller index set to 0,0,0 + sel1 = obs_data["miller_index"] != (0, 0, 0) + + # exclude reflections with overloads, as these have worse centroids + sel2 = ~obs_data.get_flags(obs_data.flags.overloaded) + + # combine selections + sel = sel1 & sel2 + inc = flex.size_t_range(len(obs_data)).select(sel) + + return inc + +
+[docs] + def print_stats_on_matches(self): + """Print some basic statistics on the matches""" + + l = self.get_matches() + nref = len(l) + if nref == 0: + logger.warning( + "Unable to calculate summary statistics for zero observations" + ) + return + + from scitbx.math import five_number_summary + + try: + x_resid = l["x_resid"] + y_resid = l["y_resid"] + wavelength_resid = l["wavelength_resid"] + w_x, w_y, w_z = l["xyzobs.mm.weights"].parts() + except KeyError: + return + + header = ["", "Min", "Q1", "Med", "Q3", "Max"] + rows = [] + row_data = five_number_summary(x_resid) + rows.append(["Xc - Xo (mm)"] + [f"{e:.4g}" for e in row_data]) + row_data = five_number_summary(y_resid) + rows.append(["Yc - Yo (mm)"] + [f"{e:.4g}" for e in row_data]) + row_data = five_number_summary(wavelength_resid) + rows.append(["Wavelengthc - Wavelengtho (A)"] + [f"{e:.4g}" for e in row_data]) + row_data = five_number_summary(w_x) + rows.append(["X weights"] + [f"{e:.4g}" for e in row_data]) + row_data = five_number_summary(w_y) + rows.append(["Y weights"] + [f"{e:.4g}" for e in row_data]) + row_data = five_number_summary(w_z) + rows.append(["Wavelength weights"] + [f"{e:.4g}" for e in row_data]) + + msg = ( + f"\nSummary statistics for {nref} observations" + " matched to predictions:" + ) + logger.info(msg) + logger.info(dials.util.tabulate(rows, header) + "\n")
+ + +
+[docs] + def update_residuals(self): + x_obs, y_obs, _ = self._reflections["xyzobs.mm.value"].parts() + x_calc, y_calc, _ = self._reflections["xyzcal.mm"].parts() + wavelength_obs = self._reflections["wavelength"] + wavelength_cal = self._reflections["wavelength_cal"] + self._reflections["x_resid"] = x_calc - x_obs + self._reflections["y_resid"] = y_calc - y_obs + self._reflections["wavelength_resid"] = wavelength_cal - wavelength_obs + self._reflections["wavelength_resid2"] = ( + self._reflections["wavelength_resid"] ** 2 + )
+
+ + + +
+[docs] +class TOFReflectionManager(LaueReflectionManager): +
+[docs] + def __init__( + self, + reflections, + experiments, + nref_per_degree=None, + max_sample_size=None, + min_sample_size=0, + close_to_spindle_cutoff=0.02, + scan_margin=0.0, + outlier_detector=None, + weighting_strategy_override=None, + wavelength_weight=1e7, + ): + + super().__init__( + reflections=reflections, + experiments=experiments, + nref_per_degree=nref_per_degree, + max_sample_size=max_sample_size, + min_sample_size=min_sample_size, + close_to_spindle_cutoff=close_to_spindle_cutoff, + scan_margin=scan_margin, + outlier_detector=outlier_detector, + weighting_strategy_override=weighting_strategy_override, + wavelength_weight=wavelength_weight, + ) + + tof_to_frame_interpolators = [] + sample_to_source_distances = [] + tof_ranges = [] + for expt in self._experiments: + tof = expt.scan.get_property("time_of_flight") # (usec) + tof_range = (min(tof), max(tof)) + tof_ranges.append(tof_range) + frames = list(range(len(tof))) + tof_to_frame = tof_helpers.tof_to_frame_interpolator(tof, frames) + tof_to_frame_interpolators.append(tof_to_frame) + sample_to_source_distances.append( + expt.beam.get_sample_to_source_distance() * 10**-3 # (m) + ) + + self._tof_to_frame_interpolators = tof_to_frame_interpolators + self._sample_to_source_distances = sample_to_source_distances + self._tof_ranges = tof_ranges
+ + +
+[docs] + def update_residuals(self): + x_obs, y_obs, _ = self._reflections["xyzobs.mm.value"].parts() + x_calc, y_calc, _ = self._reflections["xyzcal.mm"].parts() + wavelength_obs = self._reflections["wavelength"] + wavelength_cal = self._reflections["wavelength_cal"] + L2 = self._reflections["s1"].norms() * 10**-3 + self._reflections["x_resid"] = x_calc - x_obs + self._reflections["y_resid"] = y_calc - y_obs + self._reflections["wavelength_resid"] = wavelength_cal - wavelength_obs + self._reflections["wavelength_resid2"] = ( + self._reflections["wavelength_resid"] ** 2 + ) + + frame_resid = flex.double(len(self._reflections)) + frame_resid2 = flex.double(len(self._reflections)) + for idx, expt in enumerate(self._experiments): + if "imageset_id" in self._reflections: + r_expt = self._reflections["imageset_id"] == idx + else: + r_expt = self._reflections["id"] == idx + + L_expt = self._sample_to_source_distances[idx] + L2.select(r_expt) + + tof_obs_expt = ( + tof_helpers.tof_from_wavelength(L_expt, wavelength_obs.select(r_expt)) + * 10**6 + ) # (usec) + tof_obs_expt.set_selected( + tof_obs_expt < self._tof_ranges[idx][0], self._tof_ranges[idx][0] + ) + tof_obs_expt.set_selected( + tof_obs_expt > self._tof_ranges[idx][1], self._tof_ranges[idx][1] + ) + + tof_cal_expt = ( + tof_helpers.tof_from_wavelength(L_expt, wavelength_cal.select(r_expt)) + * 10**6 + ) # (usec) + tof_cal_expt.set_selected( + tof_cal_expt < self._tof_ranges[idx][0], self._tof_ranges[idx][0] + ) + tof_cal_expt.set_selected( + tof_cal_expt > self._tof_ranges[idx][1], self._tof_ranges[idx][1] + ) + + tof_to_frame = self._tof_to_frame_interpolators[idx] + frame_resid_expt = flex.double( + tof_to_frame(tof_cal_expt) - tof_to_frame(tof_obs_expt) + ) + frame_resid.set_selected(r_expt, frame_resid_expt) + frame_resid2.set_selected(r_expt, frame_resid_expt**2) + + self._reflections["frame_resid"] = frame_resid + self._reflections["frame_resid2"] = frame_resid2
+
+
diff --git a/_modules/dials/algorithms/refinement/target.html b/_modules/dials/algorithms/refinement/target.html index 2de49b1f0..591ec6bf3 100644 --- a/_modules/dials/algorithms/refinement/target.html +++ b/_modules/dials/algorithms/refinement/target.html @@ -49,7 +49,7 @@

Source code for dials.algorithms.refinement.target

from __future__ import annotations import math -from typing import Any, Tuple, Union +from typing import Any, Optional, Tuple, Union from libtbx.phil import parse from scitbx import sparse @@ -125,9 +125,23 @@

Source code for dials.algorithms.refinement.target

+ " not recognised" ) + all_tof_experiments = False + for expt in experiments: + if expt.scan is not None and expt.scan.has_property("time_of_flight"): + all_tof_experiments = True + elif all_tof_experiments: + raise ValueError( + "Cannot refine ToF and non-ToF experiments at the same time" + ) + + if all_tof_experiments: + from dials.algorithms.refinement.target import ( + TOFLeastSquaresResidualWithRmsdCutoff as targ, + ) + # Determine whether the target is in X, Y, Phi space or just X, Y to choose # the right Target to instantiate - if do_stills: + elif do_stills: if do_sparse: from dials.algorithms.refinement.target_stills import ( LeastSquaresStillsResidualWithRmsdCutoffSparse as targ, @@ -296,7 +310,11 @@

Source code for dials.algorithms.refinement.target

sel = reflections["id"] == iexp # keep all reflections if there is no rotation axis - if exp.goniometer is None: + if ( + exp.goniometer is None + or exp.scan is None + or not exp.scan.has_property("oscillation") + ): to_keep.set_selected(sel, True) continue @@ -826,6 +844,182 @@

Source code for dials.algorithms.refinement.target

pass
+ + +
+[docs] +class LaueLeastSquaresResidualWithRmsdCutoff(Target): + + """A Laue implementation of the target class providing a least squares + residual in terms of detector impact position X, Y, and observed + wavelength""" + + _grad_names = ["dX_dp", "dY_dp", "dwavelength_dp"] + rmsd_names = ["RMSD_X", "RMSD_Y", "RMSD_wavelength"] + rmsd_units = ["mm", "mm", "A"] + +
+[docs] + def __init__( + self, + experiments, + predictor, + reflection_manager, + prediction_parameterisation, + restraints_parameterisation, + frac_binsize_cutoff: float = 0.33333, + absolute_cutoffs: Optional[list] = None, + gradient_calculation_blocksize=None, + ): + + Target.__init__( + self, + experiments, + predictor, + reflection_manager, + prediction_parameterisation, + restraints_parameterisation, + gradient_calculation_blocksize, + ) + + """ + Set up the RMSD achieved criterion. + For simplicity, we take models from the first Experiment only. + If this is not appropriate for refinement over all experiments + then absolute cutoffs should be used instead. + """ + + detector = experiments[0].detector + + if not absolute_cutoffs: + # Pixel cutoffs + pixel_sizes = [p.get_pixel_size() for p in detector] + min_px_size_x = min(e[0] for e in pixel_sizes) + min_px_size_y = min(e[1] for e in pixel_sizes) + self._binsize_cutoffs = [ + min_px_size_x * frac_binsize_cutoff, + min_px_size_y * frac_binsize_cutoff, + ] + # Wavelength cutoff + self._binsize_cutoffs.append(0) + else: + assert len(absolute_cutoffs) == 3 + self._binsize_cutoffs = absolute_cutoffs
+ + + @staticmethod + def _extract_residuals_and_weights(matches): + + # return residuals and weights as 1d flex.double vectors + residuals = flex.double.concatenate(matches["x_resid"], matches["y_resid"]) + + residuals = flex.double.concatenate(residuals, matches["wavelength_resid"]) + + weights, w_y, w_z = matches["xyzobs.mm.weights"].parts() + weights.extend(w_y) + weights.extend(w_z) + + return residuals, weights + + @staticmethod + def _extract_squared_residuals(matches): + + return flex.double.concatenate( + matches["x_resid2"], + flex.double.concatenate(matches["y_resid2"], matches["wavelength_resid2"]), + ) + + def _rmsds_core(self, reflections): + + """calculate unweighted RMSDs for the specified reflections""" + + resid_x = flex.sum(reflections["x_resid2"]) + resid_y = flex.sum(reflections["y_resid2"]) + resid_wavelength = flex.sum(reflections["wavelength_resid2"]) + n = len(reflections) + + rmsds = ( + math.sqrt(resid_x / n), + math.sqrt(resid_y / n), + math.sqrt(abs(resid_wavelength) / n), + ) + return rmsds + + def _predict_core(self, reflections, skip_derivatives=False): + """perform prediction for the specified reflections""" + + # If the prediction parameterisation has a compose method (true for the scan + # varying case) then call it. Prefer hasattr to try-except duck typing to + # avoid masking AttributeErrors that could be raised within the method. + if hasattr(self._prediction_parameterisation, "compose"): + self._prediction_parameterisation.compose(reflections, skip_derivatives) + + # do prediction (updates reflection table in situ). Scan-varying prediction + # is done automatically if the crystal has scan-points (assuming reflections + # have ub_matrix set) + self._reflection_predictor(reflections) + + x_obs, y_obs, _ = reflections["xyzobs.mm.value"].parts() + x_calc, y_calc, _ = reflections["xyzcal.mm"].parts() + + # calculate residuals and assign columns + reflections["x_resid"] = x_calc - x_obs + reflections["x_resid2"] = reflections["x_resid"] ** 2 + reflections["y_resid"] = y_calc - y_obs + reflections["y_resid2"] = reflections["y_resid"] ** 2 + wavelength_obs = reflections["wavelength"] + wavelength_cal = reflections["wavelength_cal"] + reflections["wavelength_resid"] = wavelength_cal - wavelength_obs + reflections["wavelength_resid2"] = reflections["wavelength_resid"] ** 2 + + return reflections + +
+[docs] + def achieved(self): + """RMSD criterion for target achieved""" + r = self._rmsds if self._rmsds else self.rmsds() + + # reset cached rmsds to avoid getting out of step + self._rmsds = None + + if ( + r[0] < self._binsize_cutoffs[0] + and r[1] < self._binsize_cutoffs[1] + and r[2] < self._binsize_cutoffs[2] + ): + return True + return False
+
+ + + +
+[docs] +class TOFLeastSquaresResidualWithRmsdCutoff(LaueLeastSquaresResidualWithRmsdCutoff): + + _grad_names = ["dX_dp", "dY_dp", "dwavelength_dp"] + rmsd_names = ["RMSD_X", "RMSD_Y", "RMSD_wavelength", "RMSD_wavelength"] + rmsd_units = ["mm", "mm", "A", "frame"] + + def _rmsds_core(self, reflections): + + """calculate unweighted RMSDs for the specified reflections""" + + resid_x = flex.sum(reflections["x_resid2"]) + resid_y = flex.sum(reflections["y_resid2"]) + resid_wavelength = flex.sum(reflections["wavelength_resid2"]) + resid_frame = flex.sum(reflections["frame_resid2"]) + n = len(reflections) + + rmsds = ( + math.sqrt(resid_x / n), + math.sqrt(resid_y / n), + math.sqrt(abs(resid_wavelength) / n), + math.sqrt(abs(resid_frame) / n), + ) + return rmsds
+
diff --git a/_modules/dials/algorithms/refinement/weighting_strategies.html b/_modules/dials/algorithms/refinement/weighting_strategies.html index ec63076a0..033f1d87c 100644 --- a/_modules/dials/algorithms/refinement/weighting_strategies.html +++ b/_modules/dials/algorithms/refinement/weighting_strategies.html @@ -170,6 +170,70 @@

Source code for dials.algorithms.refinement.weighting_strategies

return reflections
+ + +
+[docs] +class LaueStatisticalWeightingStrategy(StatisticalWeightingStrategy): + + """ + Variance in z estimated from sqrt(x^2+y^2) + """ + +
+[docs] + def __init__( + self, + wavelength_weight: float = 1e7, + ): + self._wavelength_weight = wavelength_weight
+ + +
+[docs] + def calculate_weights(self, reflections): + + reflections = super().calculate_weights(reflections) + + wx, wy, _ = reflections["xyzobs.mm.weights"].parts() + wz = flex.sqrt(wx * wx + wy * wy) * self._wavelength_weight + reflections["xyzobs.mm.weights"] = flex.vec3_double(wx, wy, wz) + + return reflections
+
+ + + +
+[docs] +class LaueMixedWeightingStrategy(StatisticalWeightingStrategy): + + """ + Use statistical weighting for x and y, and constant weighting for z + """ + +
+[docs] + def __init__( + self, + wavelength_weight: float = 1e7, + ): + self._wavelength_weight = wavelength_weight
+ + +
+[docs] + def calculate_weights(self, reflections): + + reflections = super().calculate_weights(reflections) + + wx, wy, wz = reflections["xyzobs.mm.weights"].parts() + wz = wz * 0 + self._wavelength_weight + reflections["xyzobs.mm.weights"] = flex.vec3_double(wx, wy, wz) + + return reflections
+
+
diff --git a/documentation/library_reference/algorithms/dials.algorithms.indexing.html b/documentation/library_reference/algorithms/dials.algorithms.indexing.html index 52bdf3d66..2574a02dc 100644 --- a/documentation/library_reference/algorithms/dials.algorithms.indexing.html +++ b/documentation/library_reference/algorithms/dials.algorithms.indexing.html @@ -907,16 +907,16 @@

dials.algorithms.indexing.max_cell¶

-dials.algorithms.indexing.max_cell.find_max_cell(reflections, max_cell_multiplier=1.3, step_size=45, nearest_neighbor_percentile=None, histogram_binning='linear', nn_per_bin=5, max_height_fraction=0.25, filter_ice=True, filter_overlaps=True, overlaps_border=0)[source]¶
+dials.algorithms.indexing.max_cell.find_max_cell(reflections, max_cell_multiplier=1.3, step_size=45, nearest_neighbor_percentile=None, histogram_binning='linear', nn_per_bin=5, max_height_fraction=0.25, filter_ice=True, filter_overlaps=True, overlaps_border=0, convert_reflections_z_to_deg=True)[source]¶
-class dials.algorithms.indexing.nearest_neighbor.NeighborAnalysis(reflections, step_size=45, tolerance=1.5, max_height_fraction=0.25, percentile=None, histogram_binning='linear', nn_per_bin=5)[source]¶
+class dials.algorithms.indexing.nearest_neighbor.NeighborAnalysis(reflections, step_size=45, tolerance=1.5, max_height_fraction=0.25, percentile=None, histogram_binning='linear', nn_per_bin=5, convert_reflections_z_to_deg=True)[source]¶

Bases: object

-__init__(reflections, step_size=45, tolerance=1.5, max_height_fraction=0.25, percentile=None, histogram_binning='linear', nn_per_bin=5)[source]¶
+__init__(reflections, step_size=45, tolerance=1.5, max_height_fraction=0.25, percentile=None, histogram_binning='linear', nn_per_bin=5, convert_reflections_z_to_deg=True)[source]¶
diff --git a/documentation/library_reference/algorithms/dials.algorithms.refinement.html b/documentation/library_reference/algorithms/dials.algorithms.refinement.html index 8b5532ee9..592b11347 100644 --- a/documentation/library_reference/algorithms/dials.algorithms.refinement.html +++ b/documentation/library_reference/algorithms/dials.algorithms.refinement.html @@ -75,6 +75,33 @@
+
+
+class dials.algorithms.refinement.reflection_manager.LaueReflectionManager(reflections, experiments, nref_per_degree=None, max_sample_size=None, min_sample_size=0, close_to_spindle_cutoff=0.02, scan_margin=0.0, outlier_detector=None, weighting_strategy_override=None, wavelength_weight=10000000.0)[source]¶
+

Bases: ReflectionManager

+
+
+__init__(reflections, experiments, nref_per_degree=None, max_sample_size=None, min_sample_size=0, close_to_spindle_cutoff=0.02, scan_margin=0.0, outlier_detector=None, weighting_strategy_override=None, wavelength_weight=10000000.0)[source]¶
+
+ +
+
+experiment_type = 'laue'¶
+
+ +
+
+print_stats_on_matches()[source]¶
+

Print some basic statistics on the matches

+
+ +
+
+update_residuals()[source]¶
+
+ +
+
class dials.algorithms.refinement.reflection_manager.ReflectionManager(reflections, experiments, nref_per_degree=None, max_sample_size=None, min_sample_size=0, close_to_spindle_cutoff=0.02, scan_margin=0.0, outlier_detector=None, weighting_strategy_override=None)[source]¶
@@ -169,6 +196,11 @@ predictions

+
+
+update_residuals()[source]¶
+
+
@@ -190,6 +222,26 @@
+
+
+static get_weighting_strategy_override(params: scope_extract) StatisticalWeightingStrategy | ConstantWeightingStrategy[source]¶
+
+ +
+
+static laue_manager(experiments: ExperimentList, reflections: reflection_table, params: scope_extract) LaueReflectionManager[source]¶
+
+ +
+
+static rotation_scan_manager(experiments: ExperimentList, reflections: reflection_table, params: scope_extract) ReflectionManager[source]¶
+
+ +
+
+static stills_manager(experiments: ExperimentList, reflections: reflection_table, params: scope_extract) StillsReflectionManager[source]¶
+
+
@@ -212,6 +264,22 @@
+
+
+class dials.algorithms.refinement.reflection_manager.TOFReflectionManager(reflections, experiments, nref_per_degree=None, max_sample_size=None, min_sample_size=0, close_to_spindle_cutoff=0.02, scan_margin=0.0, outlier_detector=None, weighting_strategy_override=None, wavelength_weight=10000000.0)[source]¶
+

Bases: LaueReflectionManager

+
+
+__init__(reflections, experiments, nref_per_degree=None, max_sample_size=None, min_sample_size=0, close_to_spindle_cutoff=0.02, scan_margin=0.0, outlier_detector=None, weighting_strategy_override=None, wavelength_weight=10000000.0)[source]¶
+
+ +
+
+update_residuals()[source]¶
+
+ +
+

Contains classes used to provide weighting schemes as strategies for ReflectionManagers.

@@ -250,6 +318,42 @@
+
+
+class dials.algorithms.refinement.weighting_strategies.LaueMixedWeightingStrategy(wavelength_weight: float = 10000000.0)[source]¶
+

Bases: StatisticalWeightingStrategy

+

Use statistical weighting for x and y, and constant weighting for z

+
+
+__init__(wavelength_weight: float = 10000000.0)[source]¶
+
+ +
+
+calculate_weights(reflections)[source]¶
+

set ‘statistical weights’, that is w(x) = 1/var(x)

+
+ +
+ +
+
+class dials.algorithms.refinement.weighting_strategies.LaueStatisticalWeightingStrategy(wavelength_weight: float = 10000000.0)[source]¶
+

Bases: StatisticalWeightingStrategy

+

Variance in z estimated from sqrt(x^2+y^2)

+
+
+__init__(wavelength_weight: float = 10000000.0)[source]¶
+
+ +
+
+calculate_weights(reflections)[source]¶
+

set ‘statistical weights’, that is w(x) = 1/var(x)

+
+ +
+
class dials.algorithms.refinement.weighting_strategies.StatisticalWeightingStrategy[source]¶
@@ -931,6 +1035,36 @@

Contains classes used to construct a target function for refinement, principally Target and ReflectionManager.

+
+
+class dials.algorithms.refinement.target.LaueLeastSquaresResidualWithRmsdCutoff(experiments, predictor, reflection_manager, prediction_parameterisation, restraints_parameterisation, frac_binsize_cutoff: float = 0.33333, absolute_cutoffs: list | None = None, gradient_calculation_blocksize=None)[source]¶
+

Bases: Target

+

A Laue implementation of the target class providing a least squares +residual in terms of detector impact position X, Y, and observed +wavelength

+
+
+__init__(experiments, predictor, reflection_manager, prediction_parameterisation, restraints_parameterisation, frac_binsize_cutoff: float = 0.33333, absolute_cutoffs: list | None = None, gradient_calculation_blocksize=None)[source]¶
+
+ +
+
+achieved()[source]¶
+

RMSD criterion for target achieved

+
+ +
+
+rmsd_names = ['RMSD_X', 'RMSD_Y', 'RMSD_wavelength']¶
+
+ +
+
+rmsd_units = ['mm', 'mm', 'A']¶
+
+ +
+
class dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoff(experiments, predictor, reflection_manager, prediction_parameterisation, restraints_parameterisation, frac_binsize_cutoff=0.33333, absolute_cutoffs=None, gradient_calculation_blocksize=None)[source]¶
@@ -969,6 +1103,22 @@ that employed sparse storage.

+
+
+class dials.algorithms.refinement.target.TOFLeastSquaresResidualWithRmsdCutoff(experiments, predictor, reflection_manager, prediction_parameterisation, restraints_parameterisation, frac_binsize_cutoff: float = 0.33333, absolute_cutoffs: list | None = None, gradient_calculation_blocksize=None)[source]¶
+

Bases: LaueLeastSquaresResidualWithRmsdCutoff

+
+
+rmsd_names = ['RMSD_X', 'RMSD_Y', 'RMSD_wavelength', 'RMSD_wavelength']¶
+
+ +
+
+rmsd_units = ['mm', 'mm', 'A', 'frame']¶
+
+ +
+
class dials.algorithms.refinement.target.Target(experiments, predictor, reflection_manager, prediction_parameterisation, restraints_parameterisation=None, gradient_calculation_blocksize=None)[source]¶
diff --git a/documentation/library_reference/algorithms/index.html b/documentation/library_reference/algorithms/index.html index 63ee51b2d..41d3880ba 100644 --- a/documentation/library_reference/algorithms/index.html +++ b/documentation/library_reference/algorithms/index.html @@ -94,11 +94,15 @@

Algorithmsdials.algorithms.profile_model
  • dials.algorithms.refinement
  • -
  • achieved() (dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoff method) +
  • achieved() (dials.algorithms.refinement.target.LaueLeastSquaresResidualWithRmsdCutoff method)
      +
    • all_tof() (dxtbx.model.ExperimentList method) +
    • append() (dials.algorithms.indexing.model_evaluation.ModelRank method) + -
      • compute_functional_gradients_diag() (dials.algorithms.refinement.engine.LBFGScurvs method)
          +
        • export_as_json() (dials.algorithms.indexing.indexer.Indexer method) +
        • export_mtz() (in module dials.util.export_mtz)
        • export_reflections() (dials.algorithms.indexing.indexer.Indexer method) @@ -1764,6 +1782,8 @@

          G

        • get_vendor() (dxtbx.imageset.ImageSetData method)
        • get_vendortype() (dxtbx.imageset.ImageSet method) +
        • +
        • get_weighting_strategy_override() (dials.algorithms.refinement.reflection_manager.ReflectionManagerFactory static method)
        • Goniometer (class in dxtbx.model.goniometer)
        • @@ -2021,7 +2041,17 @@

          K

          L

          + - - + - + - +
          diff --git a/searchindex.js b/searchindex.js index 08a794487..e0b81bb61 100644 --- a/searchindex.js +++ b/searchindex.js @@ -1 +1 @@ -Search.setIndex({"alltitles": {"About": [[0, "about"]], "Acknowledgements": [[0, "acknowledgements"], [77, "acknowledgements"], [78, "acknowledgements"], [81, "acknowledgements"], [83, "acknowledgements"]], "Adding new format classes": [[4, "adding-new-format-classes"]], "Advanced use - Choosing reflections to use for minimisation": [[1, "advanced-use-choosing-reflections-to-use-for-minimisation"]], "Advanced use - Controlling the scaling models": [[1, "advanced-use-controlling-the-scaling-models"]], "Algorithms": [[19, "algorithms"]], "Almost there": [[84, "almost-there"]], "Analysis of individually processed datasets": [[83, "analysis-of-individually-processed-datasets"]], "Analysis of jointly refined datasets": [[83, "analysis-of-jointly-refined-datasets"]], "Applying the corrected metrology": [[81, "applying-the-corrected-metrology"]], "Array Family": [[20, "array-family"]], "Attendees": [[98, "attendees"]], "Basic parameters": [[34, "basic-parameters"], [36, "basic-parameters"], [37, "basic-parameters"], [38, "basic-parameters"], [39, "basic-parameters"], [40, "basic-parameters"], [41, "basic-parameters"], [42, "basic-parameters"], [43, "basic-parameters"], [44, "basic-parameters"], [45, "basic-parameters"], [46, "basic-parameters"], [47, "basic-parameters"], [49, "basic-parameters"], [50, "basic-parameters"], [51, "basic-parameters"], [52, "basic-parameters"], [53, "basic-parameters"], [54, "basic-parameters"], [55, "basic-parameters"], [57, "basic-parameters"], [58, "basic-parameters"], [59, "basic-parameters"], [60, "basic-parameters"], [61, "basic-parameters"], [62, "basic-parameters"], [63, "basic-parameters"], [64, "basic-parameters"], [65, "basic-parameters"], [66, "basic-parameters"], [67, "basic-parameters"], [68, "basic-parameters"], [69, "basic-parameters"], [70, "basic-parameters"], [72, "basic-parameters"]], "Basis vector search strategies": [[4, "basis-vector-search-strategies"]], "Bookkeeping": [[76, "bookkeeping"]], "Bravais Lattice Refinement": [[82, "bravais-lattice-refinement"], [86, "bravais-lattice-refinement"], [87, "bravais-lattice-refinement"]], "Bravais lattice determination": [[88, "bravais-lattice-determination"]], "Build instructions": [[48, "build-instructions"]], "Built-in help": [[7, "built-in-help"]], "Centred or pseudocentred?": [[77, "centred-or-pseudocentred"]], "Check indexing symmetry": [[78, "check-indexing-symmetry"]], "Checking the symmetry": [[87, "checking-the-symmetry"]], "Class Methods": [[4, "class-methods"]], "Cluster Comparisons": [[76, "cluster-comparisons"]], "Conclusions": [[77, "conclusions"], [78, "conclusions"]], "Contact": [[90, "contact"]], "Contents": [[4, "contents"]], "Conventions": [[2, "conventions"]], "Converting to a centred lattice": [[77, "converting-to-a-centred-lattice"]], "Coordinate frames": [[2, "coordinate-frames"]], "DIALS 1: 12th-13th June 2012 (Diamond Light Source, UK)": [[97, "dials-1-12th-13th-june-2012-diamond-light-source-uk"]], "DIALS Application to XFEL Crystallography": [[95, "dials-application-to-xfel-crystallography"]], "DIALS East": [[0, "dials-east"]], "DIALS How-To guides": [[89, "dials-how-to-guides"]], "DIALS Journal Articles": [[95, "dials-journal-articles"]], "DIALS License": [[92, "dials-license"]], "DIALS Newsletter Articles": [[95, "dials-newsletter-articles"]], "DIALS Reports": [[95, "dials-reports"]], "DIALS Synchrotron Applications": [[95, "dials-synchrotron-applications"]], "DIALS West": [[0, "dials-west"]], "DIALS for neutron diffraction": [[94, "dials-for-neutron-diffraction"]], "DIALS-3: 22nd May 2013 (Cambridge, UK)": [[98, "dials-3-22nd-may-2013-cambridge-uk"]], "DIALS: Diffraction Integration for Advanced Light Sources": [[90, "dials-diffraction-integration-for-advanced-light-sources"]], "DPF3 Part 1: Correcting poor initial geometry": [[78, "dpf3-part-1-correcting-poor-initial-geometry"]], "DPF3 Part 2: A question of centring": [[77, "dpf3-part-2-a-question-of-centring"]], "Data": [[74, "data"], [75, "data"], [76, "data"], [88, "data"]], "Data collection videos": [[73, "data-collection-videos"]], "Data files": [[3, "data-files"]], "Dataset 1": [[75, "dataset-1"], [75, "id1"], [75, "id11"]], "Dataset 2": [[75, "dataset-2"], [75, "id2"], [75, "id12"]], "Dataset 3": [[75, "dataset-3"], [75, "id3"], [75, "id13"]], "Dataset 4": [[75, "dataset-4"], [75, "id4"], [75, "id14"]], "Dataset 5": [[75, "dataset-5"], [75, "id5"], [75, "id15"]], "Dataset 6": [[75, "dataset-6"], [75, "id6"], [75, "id8"], [75, "id10"], [75, "id16"]], "Dataset 7": [[75, "dataset-7"], [75, "id7"], [75, "id17"]], "Datasets 1-5 & 7": [[75, "datasets-1-5-7"], [75, "id9"]], "Defining a scaling model": [[4, "defining-a-scaling-model"]], "Delta CC-half": [[76, "delta-cc-half"]], "Details": [[35, "details"]], "Detector distance": [[74, "detector-distance"]], "Determining lattice symmetry": [[74, "determining-lattice-symmetry"]], "Developer Examples": [[5, "developer-examples"]], "Development Builds": [[91, "development-builds"]], "Development Teams": [[0, "development-teams"]], "Dials parameters": [[48, "dials-parameters"]], "Discover a better experimental model": [[78, "discover-a-better-experimental-model"]], "Distl parameters": [[48, "distl-parameters"]], "Documentation": [[8, "documentation"]], "Downloading the DIALS regression test data": [[9, "downloading-the-dials-regression-test-data"]], "Entry points": [[4, "entry-points"]], "Example": [[40, "example"]], "Example use cases": [[43, "example-use-cases"]], "Examples use cases": [[72, "examples-use-cases"]], "Excluding bad frames": [[73, "excluding-bad-frames"]], "Experiment list files": [[3, "experiment-list-files"]], "Explorations of Reciprocal Space": [[76, "explorations-of-reciprocal-space"]], "Exploratory analysis": [[74, "exploratory-analysis"]], "Export": [[93, "export"]], "Export the data": [[73, "export-the-data"]], "Exporting": [[88, "exporting"]], "Exporting as MTZ": [[87, "exporting-as-mtz"]], "Exporting to unmerged MTZ": [[82, "exporting-to-unmerged-mtz"], [86, "exporting-to-unmerged-mtz"]], "Extending DIALS": [[4, "extending-dials"]], "Extending dials.index": [[4, "extending-dials-index"]], "Extending dials.scale": [[4, "extending-dials-scale"]], "Extending profile models": [[4, "extending-profile-models"]], "Extensions": [[31, "extensions"]], "Feedback": [[79, "feedback"]], "Find Spots": [[78, "find-spots"], [82, "find-spots"], [86, "find-spots"], [87, "find-spots"]], "Find spots": [[73, "find-spots"]], "Find the Bravais lattice (optional)": [[73, "find-the-bravais-lattice-optional"]], "Find the beam centre": [[73, "find-the-beam-centre"]], "Full parameter definitions": [[34, "full-parameter-definitions"], [35, "full-parameter-definitions"], [36, "full-parameter-definitions"], [37, "full-parameter-definitions"], [38, "full-parameter-definitions"], [39, "full-parameter-definitions"], [40, "full-parameter-definitions"], [41, "full-parameter-definitions"], [42, "full-parameter-definitions"], [43, "full-parameter-definitions"], [44, "full-parameter-definitions"], [45, "full-parameter-definitions"], [46, "full-parameter-definitions"], [47, "full-parameter-definitions"], [49, "full-parameter-definitions"], [50, "full-parameter-definitions"], [51, "full-parameter-definitions"], [52, "full-parameter-definitions"], [53, "full-parameter-definitions"], [54, "full-parameter-definitions"], [55, "full-parameter-definitions"], [56, "full-parameter-definitions"], [57, "full-parameter-definitions"], [58, "full-parameter-definitions"], [59, "full-parameter-definitions"], [60, "full-parameter-definitions"], [61, "full-parameter-definitions"], [62, "full-parameter-definitions"], [63, "full-parameter-definitions"], [64, "full-parameter-definitions"], [65, "full-parameter-definitions"], [66, "full-parameter-definitions"], [67, "full-parameter-definitions"], [68, "full-parameter-definitions"], [69, "full-parameter-definitions"], [70, "full-parameter-definitions"], [72, "full-parameter-definitions"]], "Funding": [[90, "funding"]], "Further processing": [[74, "further-processing"]], "Further refinement": [[74, "further-refinement"]], "General": [[79, "general"]], "General Notes": [[73, "general-notes"]], "Generate a mask for the beam center (optional)": [[73, "generate-a-mask-for-the-beam-center-optional"]], "Getting started": [[7, "getting-started"]], "Guide to common scaling options": [[1, "guide-to-common-scaling-options"]], "HTML report": [[82, "html-report"], [86, "html-report"]], "Import": [[75, "import"], [78, "import"], [82, "import"], [86, "import"], [87, "import"], [88, "import"]], "Import and Spotfinding": [[85, "import-and-spotfinding"]], "Import images": [[73, "import-images"]], "Importing": [[93, "importing"]], "Indexing": [[73, "indexing"], [74, "indexing"], [75, "indexing"], [78, "indexing"], [82, "indexing"], [85, "indexing"], [86, "indexing"], [87, "indexing"], [88, "indexing"]], "Indexing SSX data with dials.ssx_index": [[96, "indexing-ssx-data-with-dials-ssx-index"]], "Indexing with the corrected beam centre": [[78, "indexing-with-the-corrected-beam-centre"]], "Individual processing": [[83, "individual-processing"]], "Inspecting the results": [[87, "inspecting-the-results"]], "Installation": [[7, "installation"], [91, "installation"], [91, "id1"]], "Installation for Developers": [[9, "installation-for-developers"]], "Integrating SSX data with dials.ssx_integrate": [[96, "integrating-ssx-data-with-dials-ssx-integrate"]], "Integration": [[73, "integration"], [74, "integration"], [75, "integration"], [82, "integration"], [86, "integration"], [87, "integration"], [88, "integration"]], "Intensity Clustering": [[76, "intensity-clustering"]], "Introduction": [[34, "introduction"], [35, "introduction"], [36, "introduction"], [37, "introduction"], [38, "introduction"], [39, "introduction"], [40, "introduction"], [41, "introduction"], [42, "introduction"], [43, "introduction"], [44, "introduction"], [45, "introduction"], [46, "introduction"], [47, "introduction"], [48, "introduction"], [49, "introduction"], [50, "introduction"], [51, "introduction"], [52, "introduction"], [53, "introduction"], [54, "introduction"], [55, "introduction"], [56, "introduction"], [57, "introduction"], [58, "introduction"], [59, "introduction"], [60, "introduction"], [61, "introduction"], [62, "introduction"], [63, "introduction"], [64, "introduction"], [65, "introduction"], [66, "introduction"], [67, "introduction"], [68, "introduction"], [69, "introduction"], [70, "introduction"], [72, "introduction"], [74, "introduction"], [75, "introduction"], [76, "introduction"], [77, "introduction"], [78, "introduction"], [81, "introduction"], [82, "introduction"], [83, "introduction"], [84, "introduction"], [85, "introduction"], [86, "introduction"], [87, "introduction"], [88, "introduction"]], "Joint refinement": [[83, "joint-refinement"]], "Keeping a Development Environment current": [[9, "keeping-a-development-environment-current"]], "Lattice search strategies": [[4, "lattice-search-strategies"]], "Library Reference": [[32, "library-reference"]], "Lysozyme nanocrystals": [[75, "lysozyme-nanocrystals"]], "Mac and Linux binary installers": [[91, "mac-and-linux-binary-installers"]], "Mac graphical binary installers": [[91, "mac-graphical-binary-installers"]], "Manual reprocessing": [[84, "manual-reprocessing"]], "ModuleNotFoundError: No module named \u2018gltbx_gl_ext\u2019": [[9, "modulenotfounderror-no-module-named-gltbx-gl-ext"]], "Multi-crystal analysis with DIALS and BLEND: individual vs joint refinement": [[83, "multi-crystal-analysis-with-dials-and-blend-individual-vs-joint-refinement"]], "Multi-crystal analysis with DIALS and xia2.multiplex": [[76, "multi-crystal-analysis-with-dials-and-xia2-multiplex"]], "Multi-crystal symmetry analysis and scaling with DIALS": [[84, "multi-crystal-symmetry-analysis-and-scaling-with-dials"]], "Multi-dataset symmetry determination": [[73, "multi-dataset-symmetry-determination"]], "Multi-lattice Tutorial": [[85, "multi-lattice-tutorial"]], "Multi-tile refinement": [[81, "multi-tile-refinement"]], "MyD88TIR small wedges": [[74, "myd88tir-small-wedges"]], "Next steps": [[7, "next-steps"]], "Note about pedestal and offset": [[73, "note-about-pedestal-and-offset"]], "Organising committee": [[97, "organising-committee"]], "Orientation matrix": [[2, "orientation-matrix"]], "Orthogonalisation convention": [[2, "orthogonalisation-convention"]], "Other datasets": [[73, "other-datasets"]], "Output for SADABS (alternate path)": [[88, "output-for-sadabs-alternate-path"]], "Parameters": [[7, "parameters"]], "Post Experiment Processing": [[76, "post-experiment-processing"]], "Practicalities for large datasets": [[1, "practicalities-for-large-datasets"]], "Preferential Orientation": [[76, "preferential-orientation"]], "Preparing for multi-tile refinement": [[81, "preparing-for-multi-tile-refinement"]], "Process": [[76, "process"]], "Processing Sequences with Missing Images": [[93, "processing-sequences-with-missing-images"]], "Processing Small Molecule MicroED/3DED: Biotin": [[73, "processing-small-molecule-microed-3ded-biotin"]], "Processing in Detail": [[86, "processing-in-detail"]], "Processing in Detail with DUI": [[87, "processing-in-detail-with-dui"]], "Program and presentations": [[97, "program-and-presentations"], [98, "program-and-presentations"]], "Program documentation": [[71, "program-documentation"]], "Projects": [[94, "projects"]], "Publications": [[95, "publications"]], "Questioning the lattice symmetry": [[77, "questioning-the-lattice-symmetry"]], "Re-import with the correct beam center": [[73, "re-import-with-the-correct-beam-center"]], "Reading experiment and data": [[6, "reading-experiment-and-data"]], "Refine the geometry": [[73, "refine-the-geometry"]], "Refinement": [[82, "refinement"], [86, "refinement"], [87, "refinement"], [88, "refinement"], [93, "refinement"]], "Refinement and Integration": [[85, "refinement-and-integration"]], "Refining multi-tile detector metrology with DIALS": [[81, "refining-multi-tile-detector-metrology-with-dials"]], "Refining the detector distance": [[74, "refining-the-detector-distance"]], "Reflection files": [[3, "reflection-files"]], "SARS-CoV-2 main protease (Mpro)": [[82, "sars-cov-2-main-protease-mpro"]], "SSX processing guide": [[96, "ssx-processing-guide"]], "Scale the data together": [[73, "scale-the-data-together"]], "Scaling": [[73, "scaling"], [74, "scaling"], [87, "scaling"], [88, "scaling"]], "Scaling against a reference dataset": [[1, "scaling-against-a-reference-dataset"]], "Scaling and Merging": [[82, "scaling-and-merging"], [86, "scaling-and-merging"]], "Scaling and merging": [[75, "scaling-and-merging"]], "Scan-varying refinement": [[75, "scan-varying-refinement"]], "Scripted processing": [[74, "scripted-processing"]], "Sets 0-9": [[76, "sets-0-9"]], "Sets 10-19": [[76, "sets-10-19"]], "Sets 20-29": [[76, "sets-20-29"]], "Setting up a Development Environment on Linux or Mac": [[9, "setting-up-a-development-environment-on-linux-or-mac"]], "Small-molecule data reduction tutorial": [[88, "small-molecule-data-reduction-tutorial"]], "Solve the structure": [[73, "solve-the-structure"]], "Sourcing the DIALS environment": [[7, "sourcing-the-dials-environment"]], "Spot finding": [[88, "spot-finding"]], "Spot-finding": [[74, "spot-finding"], [75, "spot-finding"]], "Stable Release: DIALS 3.20.0": [[91, "stable-release-dials-3-20-0"]], "Static model refinement": [[75, "static-model-refinement"]], "Summary of coordinate frames": [[2, "summary-of-coordinate-frames"]], "Symmetry Determination": [[88, "symmetry-determination"]], "Symmetry analysis": [[82, "symmetry-analysis"], [86, "symmetry-analysis"]], "Symmetry, Scaling and Merging": [[85, "symmetry-scaling-and-merging"]], "Table of Contents": [[20, "table-of-contents"], [31, "table-of-contents"]], "Testing the server": [[48, "testing-the-server"]], "The DXTBX goniometer model": [[2, "the-dxtbx-goniometer-model"]], "The diffractometer equation": [[2, "the-diffractometer-equation"]], "The laboratory frame": [[2, "the-laboratory-frame"]], "Tilt axis orientation": [[74, "tilt-axis-orientation"]], "Tutorial data": [[82, "tutorial-data"], [86, "tutorial-data"], [87, "tutorial-data"]], "Tutorials": [[80, "tutorials"]], "Unit Cell Comparisons": [[76, "unit-cell-comparisons"]], "Unit cell refinement": [[88, "unit-cell-refinement"]], "User guide for scaling data with DIALS": [[1, "user-guide-for-scaling-data-with-dials"]], "Using DIALS at Diamond Light Source": [[79, "using-dials-at-diamond-light-source"]], "Using DIALS with xia2": [[79, "using-dials-with-xia2"]], "Util": [[33, "util"]], "What to do next": [[81, "what-to-do-next"]], "What to do next?": [[83, "what-to-do-next"]], "Workshops": [[99, "workshops"]], "Writing a new format class": [[4, "writing-a-new-format-class"]], "dials.algorithms.background": [[10, "module-dials.algorithms.background"]], "dials.algorithms.indexing": [[11, "module-dials.algorithms.indexing"]], "dials.algorithms.indexing.basis_vector_search": [[11, "module-dials.algorithms.indexing.basis_vector_search"]], "dials.algorithms.indexing.indexer": [[11, "module-dials.algorithms.indexing.indexer"]], "dials.algorithms.indexing.lattice_search": [[11, "module-dials.algorithms.indexing.lattice_search"]], "dials.algorithms.indexing.max_cell": [[11, "module-dials.algorithms.indexing.max_cell"]], "dials.algorithms.indexing.model_evaluation": [[11, "module-dials.algorithms.indexing.model_evaluation"]], "dials.algorithms.indexing.stills_indexer": [[11, "module-dials.algorithms.indexing.stills_indexer"]], "dials.algorithms.integration": [[12, "module-dials.algorithms.integration.integrator"]], "dials.algorithms.profile_model": [[13, "module-dials.algorithms.profile_model"]], "dials.algorithms.refinement": [[14, "module-dials.algorithms.refinement.reflection_manager"]], "dials.algorithms.scaling": [[15, "module-dials.algorithms.scaling"]], "dials.algorithms.spot_finding": [[16, "module-dials.algorithms.spot_finding.finder"]], "dials.algorithms.spot_prediction": [[17, "module-dials.algorithms.spot_prediction.reflection_predictor"]], "dials.algorithms.symmetry": [[18, "module-dials.algorithms.symmetry"]], "dials.algorithms.symmetry.cosym": [[18, "module-dials.algorithms.symmetry.cosym"]], "dials.align_crystal": [[34, "dials-align-crystal"]], "dials.anvil_correction": [[35, "dials-anvil-correction"]], "dials.apply_mask": [[36, "dials-apply-mask"]], "dials.check_indexing_symmetry": [[37, "dials-check-indexing-symmetry"]], "dials.combine_experiments": [[38, "dials-combine-experiments"]], "dials.compare_orientation_matrices": [[39, "dials-compare-orientation-matrices"]], "dials.cosym": [[40, "dials-cosym"]], "dials.create_profile_model": [[41, "dials-create-profile-model"]], "dials.estimate_gain": [[42, "dials-estimate-gain"]], "dials.estimate_resolution": [[43, "dials-estimate-resolution"]], "dials.export": [[44, "dials-export"]], "dials.export_bitmaps": [[45, "dials-export-bitmaps"]], "dials.filter_reflections": [[46, "dials-filter-reflections"]], "dials.find_spots": [[47, "dials-find-spots"]], "dials.find_spots_server/client": [[49, "dials-find-spots-server-client"]], "dials.generate_mask": [[50, "dials-generate-mask"]], "dials.image_viewer": [[51, "dials-image-viewer"]], "dials.import": [[52, "dials-import"]], "dials.index": [[53, "dials-index"]], "dials.integrate": [[54, "dials-integrate"]], "dials.merge_cbf": [[55, "dials-merge-cbf"]], "dials.missing_reflections": [[56, "dials-missing-reflections"]], "dials.plot_scan_varying_model": [[57, "dials-plot-scan-varying-model"]], "dials.predict": [[58, "dials-predict"]], "dials.refine": [[59, "dials-refine"]], "dials.refine_bravais_settings": [[60, "dials-refine-bravais-settings"]], "dials.reindex": [[61, "dials-reindex"]], "dials.report": [[62, "dials-report"]], "dials.scale": [[63, "dials-scale"]], "dials.search_beam_position": [[64, "dials-search-beam-position"]], "dials.show": [[65, "dials-show"]], "dials.slice_sequence": [[66, "dials-slice-sequence"]], "dials.spot_counts_per_image": [[67, "dials-spot-counts-per-image"]], "dials.stereographic_projection": [[68, "dials-stereographic-projection"]], "dials.symmetry": [[69, "dials-symmetry"]], "dials.two_theta_refine": [[70, "dials-two-theta-refine"]], "distl/dials apache server": [[48, "distl-dials-apache-server"]], "dxtbx": [[27, "dxtbx"]], "dxtbx.imageset": [[26, "module-dxtbx.imageset"]], "dxtbx.model.beam": [[21, "module-dxtbx.model.beam"]], "dxtbx.model.crystal": [[22, "dxtbx-model-crystal"]], "dxtbx.model.detector": [[23, "dxtbx-model-detector"]], "dxtbx.model.experiment_list": [[24, "dxtbx-model-experiment-list"]], "dxtbx.model.goniometer": [[25, "module-dxtbx.model.goniometer"]], "dxtbx.model.profile": [[28, "module-dxtbx.model.profile"]], "dxtbx.model.scan": [[29, "module-dxtbx.model.scan"]], "dxtbx.serialize": [[30, "module-dxtbx.serialize.imageset"]], "model.model": [[15, "module-dials.algorithms.scaling.model.model"]], "outlier_rejection": [[15, "module-dials.algorithms.scaling.outlier_rejection"]], "understand Static Method": [[4, "understand-static-method"]], "xia2.multiplex": [[72, "xia2-multiplex"], [84, "xia2-multiplex"]]}, "docnames": ["about", "dials_scale_user_guide", "documentation/conventions", "documentation/data_files", "documentation/developer_examples/extending_dials", "documentation/developer_examples/index", "documentation/developer_examples/read_experiment_and_data", "documentation/getting_started", "documentation/index", "documentation/installation_developer", "documentation/library_reference/algorithms/dials.algorithms.background", "documentation/library_reference/algorithms/dials.algorithms.indexing", "documentation/library_reference/algorithms/dials.algorithms.integration", "documentation/library_reference/algorithms/dials.algorithms.profile_model", "documentation/library_reference/algorithms/dials.algorithms.refinement", "documentation/library_reference/algorithms/dials.algorithms.scaling", "documentation/library_reference/algorithms/dials.algorithms.spot_finding", "documentation/library_reference/algorithms/dials.algorithms.spot_prediction", "documentation/library_reference/algorithms/dials.algorithms.symmetry", "documentation/library_reference/algorithms/index", "documentation/library_reference/array_family/index", "documentation/library_reference/dxtbx/beam", "documentation/library_reference/dxtbx/crystal", "documentation/library_reference/dxtbx/detector", "documentation/library_reference/dxtbx/experiment_list", "documentation/library_reference/dxtbx/goniometer", "documentation/library_reference/dxtbx/imageset", "documentation/library_reference/dxtbx/index", "documentation/library_reference/dxtbx/profile", "documentation/library_reference/dxtbx/scan", "documentation/library_reference/dxtbx/serialize", "documentation/library_reference/extensions/index", "documentation/library_reference/index", "documentation/library_reference/util/index", "documentation/programs/dials_align_crystal", "documentation/programs/dials_anvil_correction", "documentation/programs/dials_apply_mask", "documentation/programs/dials_check_indexing_symmetry", "documentation/programs/dials_combine_experiments", "documentation/programs/dials_compare_orientation_matrices", "documentation/programs/dials_cosym", "documentation/programs/dials_create_profile_model", "documentation/programs/dials_estimate_gain", "documentation/programs/dials_estimate_resolution", "documentation/programs/dials_export", "documentation/programs/dials_export_bitmaps", "documentation/programs/dials_filter_reflections", "documentation/programs/dials_find_spots", "documentation/programs/dials_find_spots_apache_server", "documentation/programs/dials_find_spots_server", "documentation/programs/dials_generate_mask", "documentation/programs/dials_image_viewer", "documentation/programs/dials_import", "documentation/programs/dials_index", "documentation/programs/dials_integrate", "documentation/programs/dials_merge_cbf", "documentation/programs/dials_missing_reflections", "documentation/programs/dials_plot_scan_varying_model", "documentation/programs/dials_predict", "documentation/programs/dials_refine", "documentation/programs/dials_refine_bravais_settings", "documentation/programs/dials_reindex", "documentation/programs/dials_report", "documentation/programs/dials_scale", "documentation/programs/dials_search_beam_position", "documentation/programs/dials_show", "documentation/programs/dials_slice_sequence", "documentation/programs/dials_spot_counts_per_image", "documentation/programs/dials_stereographic_projection", "documentation/programs/dials_symmetry", "documentation/programs/dials_two_theta_refine", "documentation/programs/index", "documentation/programs/xia2_multiplex", "documentation/tutorials/3DED/Biotin", "documentation/tutorials/3DED/MyD88", "documentation/tutorials/3DED/lysozyme_nanocrystals", "documentation/tutorials/br_lyso_multi", "documentation/tutorials/centring_vs_pseudocentring", "documentation/tutorials/correcting_poor_initial_geometry_tutorial", "documentation/tutorials/diamond", "documentation/tutorials/index", "documentation/tutorials/metrology_corrections", "documentation/tutorials/mpro_x0692", "documentation/tutorials/multi_crystal_analysis", "documentation/tutorials/multi_crystal_symmetry_and_scaling", "documentation/tutorials/multi_lattice_tutorial", "documentation/tutorials/processing_in_detail_betalactamase", "documentation/tutorials/processing_in_detail_betalactamase_dui", "documentation/tutorials/small_molecule_tutorial", "howto", "index", "installation", "license", "missing-images", "projects", "publications", "ssx_processing_guide", "workshops/DIALS-1", "workshops/dials3d", "workshops/index"], "envversion": {"sphinx": 61, "sphinx.domains.c": 3, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 9, "sphinx.domains.index": 1, "sphinx.domains.javascript": 3, "sphinx.domains.math": 2, "sphinx.domains.python": 4, "sphinx.domains.rst": 2, "sphinx.domains.std": 2, "sphinx.ext.intersphinx": 1, "sphinx.ext.viewcode": 1}, "filenames": ["about.rst", "dials_scale_user_guide.rst", "documentation/conventions.rst", "documentation/data_files.rst", "documentation/developer_examples/extending_dials.rst", "documentation/developer_examples/index.rst", "documentation/developer_examples/read_experiment_and_data.rst", "documentation/getting_started.rst", "documentation/index.rst", "documentation/installation_developer.rst", "documentation/library_reference/algorithms/dials.algorithms.background.rst", "documentation/library_reference/algorithms/dials.algorithms.indexing.rst", "documentation/library_reference/algorithms/dials.algorithms.integration.rst", "documentation/library_reference/algorithms/dials.algorithms.profile_model.rst", "documentation/library_reference/algorithms/dials.algorithms.refinement.rst", "documentation/library_reference/algorithms/dials.algorithms.scaling.rst", "documentation/library_reference/algorithms/dials.algorithms.spot_finding.rst", "documentation/library_reference/algorithms/dials.algorithms.spot_prediction.rst", "documentation/library_reference/algorithms/dials.algorithms.symmetry.rst", "documentation/library_reference/algorithms/index.rst", "documentation/library_reference/array_family/index.rst", "documentation/library_reference/dxtbx/beam.rst", "documentation/library_reference/dxtbx/crystal.rst", "documentation/library_reference/dxtbx/detector.rst", "documentation/library_reference/dxtbx/experiment_list.rst", "documentation/library_reference/dxtbx/goniometer.rst", "documentation/library_reference/dxtbx/imageset.rst", "documentation/library_reference/dxtbx/index.rst", "documentation/library_reference/dxtbx/profile.rst", "documentation/library_reference/dxtbx/scan.rst", "documentation/library_reference/dxtbx/serialize.rst", "documentation/library_reference/extensions/index.rst", "documentation/library_reference/index.rst", "documentation/library_reference/util/index.rst", "documentation/programs/dials_align_crystal.rst", "documentation/programs/dials_anvil_correction.rst", "documentation/programs/dials_apply_mask.rst", "documentation/programs/dials_check_indexing_symmetry.rst", "documentation/programs/dials_combine_experiments.rst", "documentation/programs/dials_compare_orientation_matrices.rst", "documentation/programs/dials_cosym.rst", "documentation/programs/dials_create_profile_model.rst", "documentation/programs/dials_estimate_gain.rst", "documentation/programs/dials_estimate_resolution.rst", "documentation/programs/dials_export.rst", "documentation/programs/dials_export_bitmaps.rst", "documentation/programs/dials_filter_reflections.rst", "documentation/programs/dials_find_spots.rst", "documentation/programs/dials_find_spots_apache_server.rst", "documentation/programs/dials_find_spots_server.rst", "documentation/programs/dials_generate_mask.rst", "documentation/programs/dials_image_viewer.rst", "documentation/programs/dials_import.rst", "documentation/programs/dials_index.rst", "documentation/programs/dials_integrate.rst", "documentation/programs/dials_merge_cbf.rst", "documentation/programs/dials_missing_reflections.rst", "documentation/programs/dials_plot_scan_varying_model.rst", "documentation/programs/dials_predict.rst", "documentation/programs/dials_refine.rst", "documentation/programs/dials_refine_bravais_settings.rst", "documentation/programs/dials_reindex.rst", "documentation/programs/dials_report.rst", "documentation/programs/dials_scale.rst", "documentation/programs/dials_search_beam_position.rst", "documentation/programs/dials_show.rst", "documentation/programs/dials_slice_sequence.rst", "documentation/programs/dials_spot_counts_per_image.rst", "documentation/programs/dials_stereographic_projection.rst", "documentation/programs/dials_symmetry.rst", "documentation/programs/dials_two_theta_refine.rst", "documentation/programs/index.rst", "documentation/programs/xia2_multiplex.rst", "documentation/tutorials/3DED/Biotin.rst", "documentation/tutorials/3DED/MyD88.rst", "documentation/tutorials/3DED/lysozyme_nanocrystals.rst", "documentation/tutorials/br_lyso_multi.rst", "documentation/tutorials/centring_vs_pseudocentring.rst", "documentation/tutorials/correcting_poor_initial_geometry_tutorial.rst", "documentation/tutorials/diamond.rst", "documentation/tutorials/index.rst", "documentation/tutorials/metrology_corrections.rst", "documentation/tutorials/mpro_x0692.rst", "documentation/tutorials/multi_crystal_analysis.rst", "documentation/tutorials/multi_crystal_symmetry_and_scaling.rst", "documentation/tutorials/multi_lattice_tutorial.rst", "documentation/tutorials/processing_in_detail_betalactamase.rst", "documentation/tutorials/processing_in_detail_betalactamase_dui.rst", "documentation/tutorials/small_molecule_tutorial.rst", "howto.rst", "index.rst", "installation.rst", "license.rst", "missing-images.rst", "projects.rst", "publications.rst", "ssx_processing_guide.rst", "workshops/DIALS-1.rst", "workshops/dials3d.rst", "workshops/index.rst"], "indexentries": {"__init__() (dials.algorithms.background.radialaverage method)": [[10, "dials.algorithms.background.RadialAverage.__init__", false]], "__init__() (dials.algorithms.indexing.assign_indices.assignindicesglobal method)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesGlobal.__init__", false]], "__init__() (dials.algorithms.indexing.assign_indices.assignindiceslocal method)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesLocal.__init__", false]], "__init__() (dials.algorithms.indexing.assign_indices.assignindicesstrategy method)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesStrategy.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.fft1d method)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT1D.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.fft3d method)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT3D.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.optimise.basisvectorminimiser method)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorMinimiser.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.optimise.basisvectortarget method)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorTarget.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.realspacegridsearch method)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.strategy method)": [[11, "dials.algorithms.indexing.basis_vector_search.Strategy.__init__", false]], "__init__() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.__init__", false]], "__init__() (dials.algorithms.indexing.lattice_search.lowresspotmatch method)": [[11, "dials.algorithms.indexing.lattice_search.LowResSpotMatch.__init__", false]], "__init__() (dials.algorithms.indexing.lattice_search.pinkindexer method)": [[11, "dials.algorithms.indexing.lattice_search.PinkIndexer.__init__", false]], "__init__() (dials.algorithms.indexing.lattice_search.strategy method)": [[11, "dials.algorithms.indexing.lattice_search.Strategy.__init__", false]], "__init__() (dials.algorithms.indexing.model_evaluation.modelevaluation method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelEvaluation.__init__", false]], "__init__() (dials.algorithms.indexing.model_evaluation.modelrank method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRank.__init__", false]], "__init__() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.__init__", false]], "__init__() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.__init__", false]], "__init__() (dials.algorithms.indexing.nearest_neighbor.neighboranalysis method)": [[11, "dials.algorithms.indexing.nearest_neighbor.NeighborAnalysis.__init__", false]], "__init__() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.__init__", false]], "__init__() (dials.algorithms.indexing.symmetry.symmetryhandler method)": [[11, "dials.algorithms.indexing.symmetry.SymmetryHandler.__init__", false]], "__init__() (dials.algorithms.integration.integrator.executor method)": [[12, "dials.algorithms.integration.integrator.Executor.__init__", false]], "__init__() (dials.algorithms.integration.integrator.integrator method)": [[12, "dials.algorithms.integration.integrator.Integrator.__init__", false]], "__init__() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.__init__", false]], "__init__() (dials.algorithms.integration.integrator.integratorexecutor method)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor.__init__", false]], "__init__() (dials.algorithms.integration.integrator.joblist method)": [[12, "dials.algorithms.integration.integrator.JobList.__init__", false]], "__init__() (dials.algorithms.integration.integrator.parameters method)": [[12, "dials.algorithms.integration.integrator.Parameters.__init__", false]], "__init__() (dials.algorithms.integration.integrator.parameters.filter method)": [[12, "dials.algorithms.integration.integrator.Parameters.Filter.__init__", false]], "__init__() (dials.algorithms.integration.integrator.parameters.profile method)": [[12, "dials.algorithms.integration.integrator.Parameters.Profile.__init__", false]], "__init__() (dials.algorithms.integration.integrator.parameters.profile.validation method)": [[12, "dials.algorithms.integration.integrator.Parameters.Profile.Validation.__init__", false]], "__init__() (dials.algorithms.integration.integrator.processor2d method)": [[12, "dials.algorithms.integration.integrator.Processor2D.__init__", false]], "__init__() (dials.algorithms.integration.integrator.processor3d method)": [[12, "dials.algorithms.integration.integrator.Processor3D.__init__", false]], "__init__() (dials.algorithms.integration.integrator.processorflat3d method)": [[12, "dials.algorithms.integration.integrator.ProcessorFlat3D.__init__", false]], "__init__() (dials.algorithms.integration.integrator.processorsingle2d method)": [[12, "dials.algorithms.integration.integrator.ProcessorSingle2D.__init__", false]], "__init__() (dials.algorithms.integration.integrator.processorstills method)": [[12, "dials.algorithms.integration.integrator.ProcessorStills.__init__", false]], "__init__() (dials.algorithms.integration.integrator.profilemodellerexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor.__init__", false]], "__init__() (dials.algorithms.integration.integrator.profilevalidatorexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor.__init__", false]], "__init__() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.__init__", false]], "__init__() (dials.algorithms.refinement.engine.adaptlbfgs method)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs.__init__", false]], "__init__() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.__init__", false]], "__init__() (dials.algorithms.refinement.engine.gaussnewtoniterations method)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.__init__", false]], "__init__() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.__init__", false]], "__init__() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.__init__", false]], "__init__() (dials.algorithms.refinement.reflection_manager.blockcalculator method)": [[14, "dials.algorithms.refinement.reflection_manager.BlockCalculator.__init__", false]], "__init__() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.__init__", false]], "__init__() (dials.algorithms.refinement.target.leastsquarespositionalresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoff.__init__", false]], "__init__() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.__init__", false]], "__init__() (dials.algorithms.refinement.target_stills.leastsquaresstillsresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff.__init__", false]], "__init__() (dials.algorithms.refinement.weighting_strategies.constantweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.ConstantWeightingStrategy.__init__", false]], "__init__() (dials.algorithms.refinement.weighting_strategies.stillsweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.StillsWeightingStrategy.__init__", false]], "__init__() (dials.algorithms.scaling.model.model.arrayscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.__init__", false]], "__init__() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.__init__", false]], "__init__() (dials.algorithms.scaling.model.model.kbscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.__init__", false]], "__init__() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.__init__", false]], "__init__() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.__init__", false]], "__init__() (dials.algorithms.scaling.outlier_rejection.normdevoutlierrejection method)": [[15, "dials.algorithms.scaling.outlier_rejection.NormDevOutlierRejection.__init__", false]], "__init__() (dials.algorithms.scaling.outlier_rejection.outlierrejectionbase method)": [[15, "dials.algorithms.scaling.outlier_rejection.OutlierRejectionBase.__init__", false]], "__init__() (dials.algorithms.scaling.outlier_rejection.simplenormdevoutlierrejection method)": [[15, "dials.algorithms.scaling.outlier_rejection.SimpleNormDevOutlierRejection.__init__", false]], "__init__() (dials.algorithms.scaling.outlier_rejection.targetedoutlierrejection method)": [[15, "dials.algorithms.scaling.outlier_rejection.TargetedOutlierRejection.__init__", false]], "__init__() (dials.algorithms.spot_finding.factory.backgroundgradientfilter method)": [[16, "dials.algorithms.spot_finding.factory.BackgroundGradientFilter.__init__", false]], "__init__() (dials.algorithms.spot_finding.factory.filterrunner method)": [[16, "dials.algorithms.spot_finding.factory.FilterRunner.__init__", false]], "__init__() (dials.algorithms.spot_finding.factory.peakcentroiddistancefilter method)": [[16, "dials.algorithms.spot_finding.factory.PeakCentroidDistanceFilter.__init__", false]], "__init__() (dials.algorithms.spot_finding.factory.spotdensityfilter method)": [[16, "dials.algorithms.spot_finding.factory.SpotDensityFilter.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.extractpixelsfromimage method)": [[16, "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.extractpixelsfromimage2dnoshoeboxes method)": [[16, "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage2DNoShoeboxes.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.extractspots method)": [[16, "dials.algorithms.spot_finding.finder.ExtractSpots.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.extractspotsparalleltask method)": [[16, "dials.algorithms.spot_finding.finder.ExtractSpotsParallelTask.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.spotfinder method)": [[16, "dials.algorithms.spot_finding.finder.SpotFinder.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.tofspotfinder method)": [[16, "dials.algorithms.spot_finding.finder.TOFSpotFinder.__init__", false]], "__init__() (dials.algorithms.spot_prediction.reflection_predictor.reflectionpredictor method)": [[17, "dials.algorithms.spot_prediction.reflection_predictor.ReflectionPredictor.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.cosymanalysis method)": [[18, "dials.algorithms.symmetry.cosym.CosymAnalysis.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs method)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.scoresubgroup method)": [[18, "dials.algorithms.symmetry.cosym.ScoreSubGroup.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.scoresymmetryelement method)": [[18, "dials.algorithms.symmetry.cosym.ScoreSymmetryElement.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.symmetryanalysis method)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.__init__", false]], "__init__() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.__init__", false]], "__init__() (dials.algorithms.symmetry.laue_group.lauegroupanalysis method)": [[18, "dials.algorithms.symmetry.laue_group.LaueGroupAnalysis.__init__", false]], "__init__() (dials.algorithms.symmetry.laue_group.scorecorrelationcoefficient method)": [[18, "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient.__init__", false]], "__init__() (dials.algorithms.symmetry.laue_group.scoresubgroup method)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSubGroup.__init__", false]], "__init__() (dials.algorithms.symmetry.laue_group.scoresymmetryelement method)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSymmetryElement.__init__", false]], "__init__() (dials.algorithms.symmetry.symmetry_base method)": [[18, "dials.algorithms.symmetry.symmetry_base.__init__", false]], "__init__() (dials.extensions.dispersion_spotfinder_threshold_ext.dispersionspotfinderthresholdext method)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt.__init__", false]], "__init__() (dials.extensions.null_background_ext.nullbackgroundext method)": [[31, "dials.extensions.null_background_ext.NullBackgroundExt.__init__", false]], "__init__() (dials.extensions.simple_background_ext.simplebackgroundext method)": [[31, "dials.extensions.simple_background_ext.SimpleBackgroundExt.__init__", false]], "__init__() (dials.extensions.simple_centroid_ext.simplecentroidext method)": [[31, "dials.extensions.simple_centroid_ext.SimpleCentroidExt.__init__", false]], "__init__() (dials.util.command_line.progressbar method)": [[33, "dials.util.command_line.ProgressBar.__init__", false]], "__init__() (dials.util.command_line.progressbartimer method)": [[33, "dials.util.command_line.ProgressBarTimer.__init__", false]], "__init__() (dials.util.export_mtz.mtzwriterbase method)": [[33, "dials.util.export_mtz.MTZWriterBase.__init__", false]], "__init__() (dials.util.export_mtz.wavelengthgroup method)": [[33, "dials.util.export_mtz.WavelengthGroup.__init__", false]], "__init__() (dials.util.options.argumentparser method)": [[33, "dials.util.options.ArgumentParser.__init__", false]], "__init__() (dials.util.options.argumentparserbase method)": [[33, "dials.util.options.ArgumentParserBase.__init__", false]], "__init__() (dials.util.options.importer method)": [[33, "dials.util.options.Importer.__init__", false]], "__init__() (dials.util.options.optionparser method)": [[33, "dials.util.options.OptionParser.__init__", false]], "__init__() (dials.util.options.philcommandparser method)": [[33, "dials.util.options.PhilCommandParser.__init__", false]], "__init__() (dxtbx.imageset.externallookup method)": [[26, "dxtbx.imageset.ExternalLookup.__init__", false]], "__init__() (dxtbx.imageset.externallookupitembool method)": [[26, "dxtbx.imageset.ExternalLookupItemBool.__init__", false]], "__init__() (dxtbx.imageset.externallookupitemdouble method)": [[26, "dxtbx.imageset.ExternalLookupItemDouble.__init__", false]], "__init__() (dxtbx.imageset.imagegrid method)": [[26, "dxtbx.imageset.ImageGrid.__init__", false]], "__init__() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.__init__", false]], "__init__() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.__init__", false]], "__init__() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.__init__", false]], "__init__() (dxtbx.imageset.memreader method)": [[26, "dxtbx.imageset.MemReader.__init__", false]], "__init__() (dxtbx.model.crystal method)": [[22, "dxtbx.model.Crystal.__init__", false]], "__init__() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.__init__", false]], "__init__() (dxtbx.model.experiment_list.beamcomparison method)": [[24, "dxtbx.model.experiment_list.BeamComparison.__init__", false]], "__init__() (dxtbx.model.experiment_list.detectorcomparison method)": [[24, "dxtbx.model.experiment_list.DetectorComparison.__init__", false]], "__init__() (dxtbx.model.experiment_list.goniometercomparison method)": [[24, "dxtbx.model.experiment_list.GoniometerComparison.__init__", false]], "__init__() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.__init__", false]], "__init__() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.__init__", false]], "__init__() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.__init__", false]], "__init__() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.__init__", false]], "__init__() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.__init__", false]], "__init__() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.__init__", false]], "__init__() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.__init__", false]], "accumulate() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.accumulate", false]], "accumulate() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.accumulate", false]], "achieved() (dials.algorithms.refinement.target.leastsquarespositionalresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoff.achieved", false]], "achieved() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.achieved", false]], "achieved() (dials.algorithms.refinement.target_stills.leastsquaresstillsresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff.achieved", false]], "adaptlbfgs (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs", false]], "adaptlstbx (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx", false]], "add() (dials.algorithms.background.radialaverage method)": [[10, "dials.algorithms.background.RadialAverage.add", false]], "add() (dials.algorithms.integration.integrator.joblist method)": [[12, "dials.algorithms.integration.integrator.JobList.add", false]], "add() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.add", false]], "add_batch_list() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.add_batch_list", false]], "add_column() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.add_column", false]], "add_constant_to_diagonal() (dials.algorithms.refinement.engine.levenbergmarquardtiterations method)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.add_constant_to_diagonal", false]], "add_crystal() (dials.util.export_mtz.mtzwriterbase method)": [[33, "dials.util.export_mtz.MTZWriterBase.add_crystal", false]], "add_dataset() (dials.util.export_mtz.madmergedmtzwriter method)": [[33, "dials.util.export_mtz.MADMergedMTZWriter.add_dataset", false]], "add_dataset() (dials.util.export_mtz.mergedmtzwriter method)": [[33, "dials.util.export_mtz.MergedMTZWriter.add_dataset", false]], "add_empty_dataset() (dials.util.export_mtz.mtzwriterbase method)": [[33, "dials.util.export_mtz.MTZWriterBase.add_empty_dataset", false]], "add_experiment() (dials.util.export_mtz.wavelengthgroup method)": [[33, "dials.util.export_mtz.WavelengthGroup.add_experiment", false]], "add_group() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.add_group", false]], "add_panel() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.add_panel", false]], "add_row() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.add_row", false]], "algorithm() (dials.extensions.gaussian_rs_profile_model_ext.gaussianrsprofilemodelext static method)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt.algorithm", false]], "all_laue() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.all_laue", false]], "all_rotations() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.all_rotations", false]], "all_sequences() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.all_sequences", false]], "all_stills() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.all_stills", false]], "all_tof() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.all_tof", false]], "append() (dials.algorithms.indexing.model_evaluation.modelrank method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRank.append", false]], "append() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.append", false]], "append() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.append", false]], "apply_hkl_offset() (in module dials.algorithms.indexing.indexer)": [[11, "dials.algorithms.indexing.indexer.apply_hkl_offset", false]], "apply_symmetry() (dials.algorithms.indexing.symmetry.symmetryhandler method)": [[11, "dials.algorithms.indexing.symmetry.SymmetryHandler.apply_symmetry", false]], "argumenthandlingerrorinfo (class in dials.util.options)": [[33, "dials.util.options.ArgumentHandlingErrorInfo", false]], "argumentparser (class in dials.util.options)": [[33, "dials.util.options.ArgumentParser", false]], "argumentparserbase (class in dials.util.options)": [[33, "dials.util.options.ArgumentParserBase", false]], "arrayscalingmodel (class in dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel", false]], "as_dict() (dials.algorithms.symmetry.cosym.cosymanalysis method)": [[18, "dials.algorithms.symmetry.cosym.CosymAnalysis.as_dict", false]], "as_dict() (dials.algorithms.symmetry.cosym.scoresubgroup method)": [[18, "dials.algorithms.symmetry.cosym.ScoreSubGroup.as_dict", false]], "as_dict() (dials.algorithms.symmetry.cosym.scoresymmetryelement method)": [[18, "dials.algorithms.symmetry.cosym.ScoreSymmetryElement.as_dict", false]], "as_dict() (dials.algorithms.symmetry.cosym.symmetryanalysis method)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis.as_dict", false]], "as_dict() (dials.algorithms.symmetry.laue_group.lauegroupanalysis method)": [[18, "dials.algorithms.symmetry.laue_group.LaueGroupAnalysis.as_dict", false]], "as_dict() (dials.algorithms.symmetry.laue_group.scoresubgroup method)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSubGroup.as_dict", false]], "as_dict() (dials.algorithms.symmetry.laue_group.scoresymmetryelement method)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSymmetryElement.as_dict", false]], "as_file() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.as_file", false]], "as_imageset() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.as_imageset", false]], "as_json() (dials.algorithms.symmetry.cosym.cosymanalysis method)": [[18, "dials.algorithms.symmetry.cosym.CosymAnalysis.as_json", false]], "as_json() (dials.algorithms.symmetry.laue_group.lauegroupanalysis method)": [[18, "dials.algorithms.symmetry.laue_group.LaueGroupAnalysis.as_json", false]], "as_json() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.as_json", false]], "as_str() (dxtbx.model.crystal method)": [[22, "dxtbx.model.Crystal.as_str", false]], "as_str() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.as_str", false]], "as_str() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.as_str", false]], "assignindicesglobal (class in dials.algorithms.indexing.assign_indices)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesGlobal", false]], "assignindiceslocal (class in dials.algorithms.indexing.assign_indices)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesLocal", false]], "assignindicesstrategy (class in dials.algorithms.indexing.assign_indices)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesStrategy", false]], "backgroundgradientfilter (class in dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.BackgroundGradientFilter", false]], "base_package_options (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.base_package_options", false]], "basic_imageset_from_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.basic_imageset_from_dict", false]], "basic_imageset_to_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.basic_imageset_to_dict", false]], "basisvectorminimiser (class in dials.algorithms.indexing.basis_vector_search.optimise)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorMinimiser", false]], "basisvectortarget (class in dials.algorithms.indexing.basis_vector_search.optimise)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorTarget", false]], "beamcomparison (class in dxtbx.model.experiment_list)": [[24, "dxtbx.model.experiment_list.BeamComparison", false]], "beamfactory (class in dxtbx.model.beam)": [[21, "dxtbx.model.beam.BeamFactory", false]], "beams() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.beams", false]], "best_model() (dials.algorithms.indexing.model_evaluation.modelrank method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRank.best_model", false]], "best_model() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.best_model", false]], "best_model() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.best_model", false]], "blockcalculator (class in dials.algorithms.refinement.reflection_manager)": [[14, "dials.algorithms.refinement.reflection_manager.BlockCalculator", false]], "build_up() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.build_up", false]], "calc_2d_rmsd_and_displacements() (in module dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.calc_2D_rmsd_and_displacements", false]], "calc_acentric_subgroups() (in module dials.algorithms.indexing.symmetry)": [[11, "dials.algorithms.indexing.symmetry.calc_acentric_subgroups", false]], "calc_exp_rmsd_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.calc_exp_rmsd_table", false]], "calc_n_param_from_bins() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.calc_n_param_from_bins", false]], "calculate_esds() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.calculate_esds", false]], "calculate_gradients() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.calculate_gradients", false]], "calculate_new_offset() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.calculate_new_offset", false]], "calculate_weighted_mean() (dials.util.export_mtz.wavelengthgroup method)": [[33, "dials.util.export_mtz.WavelengthGroup.calculate_weighted_mean", false]], "calculate_weights() (dials.algorithms.refinement.weighting_strategies.constantweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.ConstantWeightingStrategy.calculate_weights", false]], "calculate_weights() (dials.algorithms.refinement.weighting_strategies.externaldelpsiweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.ExternalDelPsiWeightingStrategy.calculate_weights", false]], "calculate_weights() (dials.algorithms.refinement.weighting_strategies.statisticalweightingstrategy static method)": [[14, "dials.algorithms.refinement.weighting_strategies.StatisticalWeightingStrategy.calculate_weights", false]], "calculate_weights() (dials.algorithms.refinement.weighting_strategies.stillsweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.StillsWeightingStrategy.calculate_weights", false]], "callback_after_step() (dials.algorithms.refinement.engine.adaptlbfgs method)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs.callback_after_step", false]], "callback_after_step() (dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs method)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs.callback_after_step", false]], "candidate_orientation_matrices() (in module dials.algorithms.indexing.basis_vector_search.combinations)": [[11, "dials.algorithms.indexing.basis_vector_search.combinations.candidate_orientation_matrices", false]], "change_basis() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.change_basis", false]], "change_of_basis_op_to_best_cell() (in module dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.change_of_basis_op_to_best_cell", false]], "check_flags() (dials.algorithms.spot_finding.factory.filterrunner method)": [[16, "dials.algorithms.spot_finding.factory.FilterRunner.check_flags", false]], "choose_best_orientation_matrix() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.choose_best_orientation_matrix", false]], "clear() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.clear", false]], "clear_cache() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.clear_cache", false]], "coefficient() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.coefficient", false]], "coloured() (in module dials.util.command_line)": [[33, "dials.util.command_line.coloured", false]], "combined_scores() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.combined_scores", false]], "command (class in dials.util.command_line)": [[33, "dials.util.command_line.Command", false]], "complete_set() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.complete_set", false]], "complete_set() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.complete_set", false]], "complex() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.complex", false]], "complex() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.complex", false]], "components (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.components", false]], "compute_background() (dials.extensions.null_background_ext.nullbackgroundext method)": [[31, "dials.extensions.null_background_ext.NullBackgroundExt.compute_background", false]], "compute_background() (dials.extensions.simple_background_ext.simplebackgroundext method)": [[31, "dials.extensions.simple_background_ext.SimpleBackgroundExt.compute_background", false]], "compute_centroid() (dials.extensions.simple_centroid_ext.simplecentroidext method)": [[31, "dials.extensions.simple_centroid_ext.SimpleCentroidExt.compute_centroid", false]], "compute_functional() (dials.algorithms.indexing.basis_vector_search.optimise.basisvectortarget method)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorTarget.compute_functional", false]], "compute_functional() (dials.algorithms.indexing.basis_vector_search.realspacegridsearch static method)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.compute_functional", false]], "compute_functional() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.compute_functional", false]], "compute_functional_and_gradients() (dials.algorithms.indexing.basis_vector_search.optimise.basisvectorminimiser method)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorMinimiser.compute_functional_and_gradients", false]], "compute_functional_and_gradients() (dials.algorithms.indexing.basis_vector_search.optimise.basisvectortarget method)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorTarget.compute_functional_and_gradients", false]], "compute_functional_and_gradients() (dials.algorithms.refinement.engine.adaptlbfgs method)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs.compute_functional_and_gradients", false]], "compute_functional_and_gradients() (dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs method)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs.compute_functional_and_gradients", false]], "compute_functional_gradients_and_curvatures() (dials.algorithms.refinement.engine.adaptlbfgs method)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs.compute_functional_gradients_and_curvatures", false]], "compute_functional_gradients_and_curvatures() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.compute_functional_gradients_and_curvatures", false]], "compute_functional_gradients_and_curvatures() (dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs method)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs.compute_functional_gradients_and_curvatures", false]], "compute_functional_gradients_diag() (dials.algorithms.refinement.engine.lbfgscurvs method)": [[14, "dials.algorithms.refinement.engine.LBFGScurvs.compute_functional_gradients_diag", false]], "compute_functional_gradients_diag() (dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs method)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs.compute_functional_gradients_diag", false]], "compute_gradients() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.compute_gradients", false]], "compute_gradients_fd() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.compute_gradients_fd", false]], "compute_residuals() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.compute_residuals", false]], "compute_residuals_and_gradients() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.compute_residuals_and_gradients", false]], "compute_restraints_functional_gradients_and_curvatures() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.compute_restraints_functional_gradients_and_curvatures", false]], "compute_restraints_residuals_and_gradients() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.compute_restraints_residuals_and_gradients", false]], "compute_threshold() (dials.extensions.dispersion_spotfinder_threshold_ext.dispersionspotfinderthresholdext method)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt.compute_threshold", false]], "config_refinery() (dials.algorithms.refinement.refiner.refinerfactory static method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.config_refinery", false]], "config_restraints() (dials.algorithms.refinement.refiner.refinerfactory static method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.config_restraints", false]], "config_sparse() (dials.algorithms.refinement.refiner.refinerfactory static method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.config_sparse", false]], "config_target() (dials.algorithms.refinement.refiner.refinerfactory static method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.config_target", false]], "configdict (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.configdict", false]], "configure_components() (dials.algorithms.scaling.model.model.arrayscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.configure_components", false]], "configure_components() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.configure_components", false]], "configure_components() (dials.algorithms.scaling.model.model.kbscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.configure_components", false]], "configure_components() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.configure_components", false]], "configure_components() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.configure_components", false]], "configure_filter() (dials.algorithms.spot_finding.factory.spotfinderfactory static method)": [[16, "dials.algorithms.spot_finding.factory.SpotFinderFactory.configure_filter", false]], "configure_modules (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.configure_modules", false]], "configure_threshold() (dials.algorithms.spot_finding.factory.spotfinderfactory static method)": [[16, "dials.algorithms.spot_finding.factory.SpotFinderFactory.configure_threshold", false]], "consecutive_refinement_order (dials.algorithms.scaling.model.model.arrayscalingmodel property)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.consecutive_refinement_order", false]], "consecutive_refinement_order (dials.algorithms.scaling.model.model.dosedecay property)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.consecutive_refinement_order", false]], "consecutive_refinement_order (dials.algorithms.scaling.model.model.kbscalingmodel property)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.consecutive_refinement_order", false]], "consecutive_refinement_order (dials.algorithms.scaling.model.model.physicalscalingmodel property)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.consecutive_refinement_order", false]], "consecutive_refinement_order() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.consecutive_refinement_order", false]], "constantweightingstrategy (class in dials.algorithms.refinement.weighting_strategies)": [[14, "dials.algorithms.refinement.weighting_strategies.ConstantWeightingStrategy", false]], "convergence_as_shift_over_esd (dials.algorithms.refinement.engine.gaussnewtoniterations attribute)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.convergence_as_shift_over_esd", false]], "convert_to_cambridge() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.convert_to_cambridge", false]], "copy() (dxtbx.imageset.memreader method)": [[26, "dxtbx.imageset.MemReader.copy", false]], "correlationcoefficientaccumulator (class in dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator", false]], "cosymanalysis (class in dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.CosymAnalysis", false]], "crystal (class in dxtbx.model)": [[22, "dxtbx.model.Crystal", false]], "crystal (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.crystal", false]], "crystal() (in module dxtbx.serialize.load)": [[30, "dxtbx.serialize.load.crystal", false]], "crystalfactory (class in dxtbx.model.crystal)": [[22, "dxtbx.model.crystal.CrystalFactory", false]], "crystals() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.crystals", false]], "curvatures() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.curvatures", false]], "curvatures_fd() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.curvatures_fd", false]], "damping_value (dials.algorithms.refinement.engine.gaussnewtoniterations attribute)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.damping_value", false]], "data (dxtbx.imageset.externallookupitembool property)": [[26, "dxtbx.imageset.ExternalLookupItemBool.data", false]], "data (dxtbx.imageset.externallookupitemdouble property)": [[26, "dxtbx.imageset.ExternalLookupItemDouble.data", false]], "data() (dials.algorithms.integration.integrator.integratorexecutor method)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor.data", false]], "data() (dials.algorithms.integration.integrator.profilemodellerexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor.data", false]], "data() (dials.algorithms.integration.integrator.profilevalidatorexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor.data", false]], "data() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.data", false]], "data() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.data", false]], "default (dials.extensions.gaussian_rs_profile_model_ext.gaussianrsprofilemodelext attribute)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt.default", false]], "default (dials.extensions.simple_centroid_ext.simplecentroidext attribute)": [[31, "dials.extensions.simple_centroid_ext.SimpleCentroidExt.default", false]], "del_last_row() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.del_last_row", false]], "denominator() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.denominator", false]], "dest_dir_prefix (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.dest_dir_prefix", false]], "detector (class in dxtbx.model)": [[23, "dxtbx.model.Detector", false]], "detectorcomparison (class in dxtbx.model.experiment_list)": [[24, "dxtbx.model.experiment_list.DetectorComparison", false]], "detectorfactory (class in dxtbx.model.detector)": [[23, "dxtbx.model.detector.DetectorFactory", false]], "detectors() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.detectors", false]], "determine_auto_absorption_params() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.determine_auto_absorption_params", false]], "determine_esq_outlier_index_arrays() (in module dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.determine_Esq_outlier_index_arrays", false]], "determine_outlier_index_arrays() (in module dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.determine_outlier_index_arrays", false]], "determine_reindex_operator_against_reference() (in module dials.algorithms.symmetry.reindex_to_reference)": [[18, "dials.algorithms.symmetry.reindex_to_reference.determine_reindex_operator_against_reference", false]], "dials.algorithms.background": [[10, "module-dials.algorithms.background", false]], "dials.algorithms.indexing": [[11, "module-dials.algorithms.indexing", false]], "dials.algorithms.indexing.assign_indices": [[11, "module-dials.algorithms.indexing.assign_indices", false]], "dials.algorithms.indexing.basis_vector_search": [[11, "module-dials.algorithms.indexing.basis_vector_search", false]], "dials.algorithms.indexing.basis_vector_search.combinations": [[11, "module-dials.algorithms.indexing.basis_vector_search.combinations", false]], "dials.algorithms.indexing.basis_vector_search.optimise": [[11, "module-dials.algorithms.indexing.basis_vector_search.optimise", false]], "dials.algorithms.indexing.compare_orientation_matrices": [[11, "module-dials.algorithms.indexing.compare_orientation_matrices", false]], "dials.algorithms.indexing.indexer": [[11, "module-dials.algorithms.indexing.indexer", false]], "dials.algorithms.indexing.lattice_search": [[11, "module-dials.algorithms.indexing.lattice_search", false]], "dials.algorithms.indexing.max_cell": [[11, "module-dials.algorithms.indexing.max_cell", false]], "dials.algorithms.indexing.model_evaluation": [[11, "module-dials.algorithms.indexing.model_evaluation", false]], "dials.algorithms.indexing.nearest_neighbor": [[11, "module-dials.algorithms.indexing.nearest_neighbor", false]], "dials.algorithms.indexing.refinement": [[11, "module-dials.algorithms.indexing.refinement", false]], "dials.algorithms.indexing.stills_indexer": [[11, "module-dials.algorithms.indexing.stills_indexer", false]], "dials.algorithms.indexing.symmetry": [[11, "module-dials.algorithms.indexing.symmetry", false]], "dials.algorithms.integration.integrator": [[12, "module-dials.algorithms.integration.integrator", false]], "dials.algorithms.profile_model": [[13, "module-dials.algorithms.profile_model", false]], "dials.algorithms.refinement.engine": [[14, "module-dials.algorithms.refinement.engine", false]], "dials.algorithms.refinement.refiner": [[14, "module-dials.algorithms.refinement.refiner", false]], "dials.algorithms.refinement.reflection_manager": [[14, "module-dials.algorithms.refinement.reflection_manager", false]], "dials.algorithms.refinement.target": [[14, "module-dials.algorithms.refinement.target", false]], "dials.algorithms.refinement.target_stills": [[14, "module-dials.algorithms.refinement.target_stills", false]], "dials.algorithms.refinement.weighting_strategies": [[14, "module-dials.algorithms.refinement.weighting_strategies", false]], "dials.algorithms.scaling": [[15, "module-dials.algorithms.scaling", false]], "dials.algorithms.scaling.model.model": [[15, "module-dials.algorithms.scaling.model.model", false]], "dials.algorithms.scaling.outlier_rejection": [[15, "module-dials.algorithms.scaling.outlier_rejection", false]], "dials.algorithms.spot_finding.factory": [[16, "module-dials.algorithms.spot_finding.factory", false]], "dials.algorithms.spot_finding.finder": [[16, "module-dials.algorithms.spot_finding.finder", false]], "dials.algorithms.spot_prediction.reflection_predictor": [[17, "module-dials.algorithms.spot_prediction.reflection_predictor", false]], "dials.algorithms.symmetry": [[18, "module-dials.algorithms.symmetry", false]], "dials.algorithms.symmetry.cosym": [[18, "module-dials.algorithms.symmetry.cosym", false]], "dials.algorithms.symmetry.cosym.engine": [[18, "module-dials.algorithms.symmetry.cosym.engine", false]], "dials.algorithms.symmetry.cosym.target": [[18, "module-dials.algorithms.symmetry.cosym.target", false]], "dials.algorithms.symmetry.laue_group": [[18, "module-dials.algorithms.symmetry.laue_group", false]], "dials.algorithms.symmetry.reindex_to_reference": [[18, "module-dials.algorithms.symmetry.reindex_to_reference", false]], "dials.array_family.flex": [[20, "module-dials.array_family.flex", false]], "dials.extensions.dispersion_spotfinder_threshold_ext": [[31, "module-dials.extensions.dispersion_spotfinder_threshold_ext", false]], "dials.extensions.gaussian_rs_profile_model_ext": [[31, "module-dials.extensions.gaussian_rs_profile_model_ext", false]], "dials.extensions.null_background_ext": [[31, "module-dials.extensions.null_background_ext", false]], "dials.extensions.simple_background_ext": [[31, "module-dials.extensions.simple_background_ext", false]], "dials.extensions.simple_centroid_ext": [[31, "module-dials.extensions.simple_centroid_ext", false]], "dials.util.command_line": [[33, "module-dials.util.command_line", false]], "dials.util.export_mtz": [[33, "module-dials.util.export_mtz", false]], "dials.util.export_text": [[33, "module-dials.util.export_text", false]], "dials.util.image": [[33, "module-dials.util.image", false]], "dials.util.installer": [[33, "module-dials.util.installer", false]], "dials.util.ioutil": [[33, "module-dials.util.ioutil", false]], "dials.util.nexus": [[33, "module-dials.util.nexus", false]], "dials.util.options": [[33, "module-dials.util.options", false]], "dialsindexerror": [[11, "dials.algorithms.indexing.DialsIndexError", false]], "dialsindexrefineerror": [[11, "dials.algorithms.indexing.DialsIndexRefineError", false]], "diff_phil (dials.util.options.argumentparser property)": [[33, "dials.util.options.ArgumentParser.diff_phil", false]], "diff_phil (dials.util.options.philcommandparser property)": [[33, "dials.util.options.PhilCommandParser.diff_phil", false]], "difference_rotation_matrix_axis_angle() (in module dials.algorithms.indexing.compare_orientation_matrices)": [[11, "dials.algorithms.indexing.compare_orientation_matrices.difference_rotation_matrix_axis_angle", false]], "dim (dials.algorithms.refinement.target.target property)": [[14, "dials.algorithms.refinement.target.Target.dim", false]], "dim (dials.algorithms.symmetry.cosym.target.target attribute)": [[18, "dials.algorithms.symmetry.cosym.target.Target.dim", false]], "disablempmixin (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.DisableMPmixin", false]], "dispersionspotfinderthresholdext (class in dials.extensions.dispersion_spotfinder_threshold_ext)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt", false]], "dosedecay (class in dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.DoseDecay", false]], "dump() (in module dials.util.nexus)": [[33, "dials.util.nexus.dump", false]], "dx (dxtbx.imageset.externallookup property)": [[26, "dxtbx.imageset.ExternalLookup.dx", false]], "dxtbx.imageset": [[26, "module-dxtbx.imageset", false]], "dxtbx.model.beam": [[21, "module-dxtbx.model.beam", false]], "dxtbx.model.crystal": [[22, "module-dxtbx.model.crystal", false]], "dxtbx.model.detector": [[23, "module-dxtbx.model.detector", false]], "dxtbx.model.experiment_list": [[24, "module-dxtbx.model.experiment_list", false]], "dxtbx.model.goniometer": [[25, "module-dxtbx.model.goniometer", false]], "dxtbx.model.profile": [[28, "module-dxtbx.model.profile", false]], "dxtbx.model.scan": [[29, "module-dxtbx.model.scan", false]], "dxtbx.serialize.imageset": [[30, "module-dxtbx.serialize.imageset", false]], "dxtbx.serialize.load": [[30, "module-dxtbx.serialize.load", false]], "dxtbx.serialize.xds": [[30, "module-dxtbx.serialize.xds", false]], "dy (dxtbx.imageset.externallookup property)": [[26, "dxtbx.imageset.ExternalLookup.dy", false]], "e_refine() (in module dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.e_refine", false]], "empty() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.empty", false]], "end() (dials.util.command_line.command class method)": [[33, "dials.util.command_line.Command.end", false]], "error_model (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.error_model", false]], "estimate_global_threshold() (in module dials.extensions.dispersion_spotfinder_threshold_ext)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.estimate_global_threshold", false]], "evaluate() (dials.algorithms.indexing.model_evaluation.modelevaluation method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelEvaluation.evaluate", false]], "evaluate() (dials.algorithms.indexing.model_evaluation.strategy method)": [[11, "dials.algorithms.indexing.model_evaluation.Strategy.evaluate", false]], "exception (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.exception", false]], "executor (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Executor", false]], "exp_nos (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.exp_nos", false]], "experiment_list() (in module dxtbx.serialize.load)": [[30, "dxtbx.serialize.load.experiment_list", false]], "experiment_list_for_crystal() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.experiment_list_for_crystal", false]], "experiment_type (dials.algorithms.refinement.reflection_manager.reflectionmanager attribute)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.experiment_type", false]], "experiment_type (dials.algorithms.refinement.reflection_manager.stillsreflectionmanager attribute)": [[14, "dials.algorithms.refinement.reflection_manager.StillsReflectionManager.experiment_type", false]], "experimentlist (class in dxtbx.model)": [[24, "dxtbx.model.ExperimentList", false]], "experimentlistfactory (class in dxtbx.model.experiment_list)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory", false]], "export_as_json() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.export_as_json", false]], "export_mtz() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.export_mtz", false]], "export_reflections() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.export_reflections", false]], "export_text() (in module dials.util.export_text)": [[33, "dials.util.export_text.export_text", false]], "extend() (dials.algorithms.indexing.model_evaluation.modelrank method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRank.extend", false]], "extend() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.extend", false]], "extend() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.extend", false]], "external_lookup (dxtbx.imageset.imageset property)": [[26, "dxtbx.imageset.ImageSet.external_lookup", false]], "external_lookup (dxtbx.imageset.imagesetdata property)": [[26, "dxtbx.imageset.ImageSetData.external_lookup", false]], "externaldelpsiweightingstrategy (class in dials.algorithms.refinement.weighting_strategies)": [[14, "dials.algorithms.refinement.weighting_strategies.ExternalDelPsiWeightingStrategy", false]], "externallookup (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ExternalLookup", false]], "externallookupitembool (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ExternalLookupItemBool", false]], "externallookupitemdouble (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ExternalLookupItemDouble", false]], "extract_reference_intensities() (in module dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.extract_reference_intensities", false]], "extractpixelsfromimage (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage", false]], "extractpixelsfromimage2dnoshoeboxes (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage2DNoShoeboxes", false]], "extractspots (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.ExtractSpots", false]], "extractspotsparalleltask (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.ExtractSpotsParallelTask", false]], "fft1d (class in dials.algorithms.indexing.basis_vector_search)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT1D", false]], "fft3d (class in dials.algorithms.indexing.basis_vector_search)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT3D", false]], "filename (dxtbx.imageset.externallookupitembool property)": [[26, "dxtbx.imageset.ExternalLookupItemBool.filename", false]], "filename (dxtbx.imageset.externallookupitemdouble property)": [[26, "dxtbx.imageset.ExternalLookupItemDouble.filename", false]], "filename_or_none() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.filename_or_none", false]], "filename_to_absolute() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.filename_to_absolute", false]], "filter_by_likelihood() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.filter_by_likelihood", false]], "filter_by_n_indexed() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.filter_by_n_indexed", false]], "filter_by_volume() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.filter_by_volume", false]], "filter_doubled_cell() (in module dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.filter_doubled_cell", false]], "filter_known_symmetry() (in module dials.algorithms.indexing.basis_vector_search.combinations)": [[11, "dials.algorithms.indexing.basis_vector_search.combinations.filter_known_symmetry", false]], "filter_obs() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.filter_obs", false]], "filter_similar_orientations() (in module dials.algorithms.indexing.basis_vector_search.combinations)": [[11, "dials.algorithms.indexing.basis_vector_search.combinations.filter_similar_orientations", false]], "filterrunner (class in dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.FilterRunner", false]], "final_outlier_arrays (dials.algorithms.scaling.outlier_rejection.outlierrejectionbase attribute)": [[15, "dials.algorithms.scaling.outlier_rejection.OutlierRejectionBase.final_outlier_arrays", false]], "finalise() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.finalise", false]], "finalise() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.finalise", false]], "finalize() (dials.algorithms.integration.integrator.integratorexecutor method)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor.finalize", false]], "finalize() (dials.algorithms.integration.integrator.profilemodellerexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor.finalize", false]], "finalize() (dials.algorithms.integration.integrator.profilevalidatorexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor.finalize", false]], "finalize_reflections() (dials.algorithms.integration.integrator.integrator2d static method)": [[12, "dials.algorithms.integration.integrator.Integrator2D.finalize_reflections", false]], "finalize_reflections() (dials.algorithms.integration.integrator.integrator3d static method)": [[12, "dials.algorithms.integration.integrator.Integrator3D.finalize_reflections", false]], "finalize_reflections() (dials.algorithms.integration.integrator.integratorflat3d static method)": [[12, "dials.algorithms.integration.integrator.IntegratorFlat3D.finalize_reflections", false]], "finalize_reflections() (dials.algorithms.integration.integrator.integratorsingle2d static method)": [[12, "dials.algorithms.integration.integrator.IntegratorSingle2D.finalize_reflections", false]], "finalize_reflections() (dials.algorithms.integration.integrator.integratorstills static method)": [[12, "dials.algorithms.integration.integrator.IntegratorStills.finalize_reflections", false]], "find() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.find", false]], "find_basis_vectors() (dials.algorithms.indexing.basis_vector_search.fft1d method)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT1D.find_basis_vectors", false]], "find_basis_vectors() (dials.algorithms.indexing.basis_vector_search.fft3d method)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT3D.find_basis_vectors", false]], "find_basis_vectors() (dials.algorithms.indexing.basis_vector_search.realspacegridsearch method)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.find_basis_vectors", false]], "find_basis_vectors() (dials.algorithms.indexing.basis_vector_search.strategy method)": [[11, "dials.algorithms.indexing.basis_vector_search.Strategy.find_basis_vectors", false]], "find_crystal_models() (dials.algorithms.indexing.lattice_search.lowresspotmatch method)": [[11, "dials.algorithms.indexing.lattice_search.LowResSpotMatch.find_crystal_models", false]], "find_crystal_models() (dials.algorithms.indexing.lattice_search.pinkindexer method)": [[11, "dials.algorithms.indexing.lattice_search.PinkIndexer.find_crystal_models", false]], "find_crystal_models() (dials.algorithms.indexing.lattice_search.strategy method)": [[11, "dials.algorithms.indexing.lattice_search.Strategy.find_crystal_models", false]], "find_lattices() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.find_lattices", false]], "find_matching_symmetry() (in module dials.algorithms.indexing.symmetry)": [[11, "dials.algorithms.indexing.symmetry.find_matching_symmetry", false]], "find_max_cell() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.find_max_cell", false]], "find_max_cell() (in module dials.algorithms.indexing.max_cell)": [[11, "dials.algorithms.indexing.max_cell.find_max_cell", false]], "find_spots() (dials.algorithms.spot_finding.finder.spotfinder method)": [[16, "dials.algorithms.spot_finding.finder.SpotFinder.find_spots", false]], "finished() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.finished", false]], "finished() (dials.util.command_line.progressbar method)": [[33, "dials.util.command_line.ProgressBar.finished", false]], "fit_profiles() (dials.algorithms.integration.integrator.integrator method)": [[12, "dials.algorithms.integration.integrator.Integrator.fit_profiles", false]], "fix_initial_parameter() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.fix_initial_parameter", false]], "fix_initial_parameter() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.fix_initial_parameter", false]], "fix_initial_parameter() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.fix_initial_parameter", false]], "fixed_components (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.fixed_components", false]], "flatten_experiments() (in module dials.util.options)": [[33, "dials.util.options.flatten_experiments", false]], "flatten_reflections() (in module dials.util.options)": [[33, "dials.util.options.flatten_reflections", false]], "format_epilog() (dials.util.options.argumentparserbase method)": [[33, "dials.util.options.ArgumentParserBase.format_epilog", false]], "format_help() (dials.util.options.argumentparser method)": [[33, "dials.util.options.ArgumentParser.format_help", false]], "fraction_indexed (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.fraction_indexed", false]], "frame_hist() (in module dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.frame_hist", false]], "from_args() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_args", false]], "from_data() (dials.algorithms.scaling.model.model.arrayscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.from_data", false]], "from_data() (dials.algorithms.scaling.model.model.dosedecay class method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.from_data", false]], "from_data() (dials.algorithms.scaling.model.model.kbscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.from_data", false]], "from_data() (dials.algorithms.scaling.model.model.physicalscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.from_data", false]], "from_data() (dials.algorithms.scaling.model.model.scalingmodelbase class method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.from_data", false]], "from_dict() (dials.algorithms.scaling.model.model.arrayscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.from_dict", false]], "from_dict() (dials.algorithms.scaling.model.model.dosedecay class method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.from_dict", false]], "from_dict() (dials.algorithms.scaling.model.model.kbscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.from_dict", false]], "from_dict() (dials.algorithms.scaling.model.model.physicalscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.from_dict", false]], "from_dict() (dials.algorithms.scaling.model.model.scalingmodelbase class method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.from_dict", false]], "from_dict() (dials.extensions.gaussian_rs_profile_model_ext.gaussianrsprofilemodelext class method)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt.from_dict", false]], "from_dict() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.from_dict", false]], "from_dict() (dxtbx.model.crystal static method)": [[22, "dxtbx.model.Crystal.from_dict", false]], "from_dict() (dxtbx.model.crystal.crystalfactory static method)": [[22, "dxtbx.model.crystal.CrystalFactory.from_dict", false]], "from_dict() (dxtbx.model.detector static method)": [[23, "dxtbx.model.Detector.from_dict", false]], "from_dict() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.from_dict", false]], "from_dict() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_dict", false]], "from_dict() (dxtbx.model.goniometer.goniometer static method)": [[25, "dxtbx.model.goniometer.Goniometer.from_dict", false]], "from_dict() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.from_dict", false]], "from_dict() (dxtbx.model.goniometer.multiaxisgoniometer static method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.from_dict", false]], "from_dict() (dxtbx.model.mosaiccrystalkabsch2010 class method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.from_dict", false]], "from_dict() (dxtbx.model.mosaiccrystalsauter2014 class method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.from_dict", false]], "from_dict() (dxtbx.model.profile.profilemodelfactory static method)": [[28, "dxtbx.model.profile.ProfileModelFactory.from_dict", false]], "from_dict() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.from_dict", false]], "from_file() (dxtbx.model.experimentlist static method)": [[24, "dxtbx.model.ExperimentList.from_file", false]], "from_filenames() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_filenames", false]], "from_imageset() (dxtbx.imageset.imagegrid static method)": [[26, "dxtbx.imageset.ImageGrid.from_imageset", false]], "from_imageset_and_crystal() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_imageset_and_crystal", false]], "from_json() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_json", false]], "from_json_file() (dials.algorithms.refinement.engine.journal class method)": [[14, "dials.algorithms.refinement.engine.Journal.from_json_file", false]], "from_json_file() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_json_file", false]], "from_mosflm_matrix() (dxtbx.model.crystal.crystalfactory static method)": [[22, "dxtbx.model.crystal.CrystalFactory.from_mosflm_matrix", false]], "from_parameters() (dials.algorithms.indexing.indexer.indexer static method)": [[11, "dials.algorithms.indexing.indexer.Indexer.from_parameters", false]], "from_parameters() (dials.algorithms.spot_finding.factory.spotfinderfactory static method)": [[16, "dials.algorithms.spot_finding.factory.SpotFinderFactory.from_parameters", false]], "from_parameters_and_experiments() (dials.algorithms.refinement.target.targetfactory static method)": [[14, "dials.algorithms.refinement.target.TargetFactory.from_parameters_and_experiments", false]], "from_parameters_data_experiments() (dials.algorithms.refinement.refiner.refinerfactory class method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.from_parameters_data_experiments", false]], "from_parameters_reflections_experiments() (dials.algorithms.refinement.reflection_manager.reflectionmanagerfactory static method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManagerFactory.from_parameters_reflections_experiments", false]], "from_phil() (dials.algorithms.integration.integrator.parameters static method)": [[12, "dials.algorithms.integration.integrator.Parameters.from_phil", false]], "from_phil() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.from_phil", false]], "from_phil() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.from_phil", false]], "from_phil() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.from_phil", false]], "from_phil() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.from_phil", false]], "from_pickle_file() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_pickle_file", false]], "from_sequence_and_crystal() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_sequence_and_crystal", false]], "from_serialized_format() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_serialized_format", false]], "from_stills_and_crystal() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_stills_and_crystal", false]], "from_template() (dxtbx.imageset.imagesetfactory static method)": [[26, "dxtbx.imageset.ImageSetFactory.from_template", false]], "from_templates() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_templates", false]], "from_templates() (dxtbx.model.experimentlist static method)": [[24, "dxtbx.model.ExperimentList.from_templates", false]], "from_xds() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_xds", false]], "gain (dxtbx.imageset.externallookup property)": [[26, "dxtbx.imageset.ExternalLookup.gain", false]], "gaussianrsprofilemodelext (class in dials.extensions.gaussian_rs_profile_model_ext)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt", false]], "gaussnewtoniterations (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations", false]], "generate_from_phil() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.generate_from_phil", false]], "generate_phil_scope() (in module dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.generate_phil_scope", false]], "generate_phil_scope() (in module dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.generate_phil_scope", false]], "get_a_as_sqr() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.get_A_as_sqr", false]], "get_a_inverse_as_sqr() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.get_A_inverse_as_sqr", false]], "get_accepted_refs_size() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_accepted_refs_size", false]], "get_alpha_angle() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_alpha_angle", false]], "get_angles() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.get_angles", false]], "get_array_range() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_array_range", false]], "get_axes() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.get_axes", false]], "get_beam() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_beam", false]], "get_beam() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_beam", false]], "get_beam() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_beam", false]], "get_beam() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_beam", false]], "get_beam() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.get_beam", false]], "get_centroid_analyser() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_centroid_analyser", false]], "get_corrected_data() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_corrected_data", false]], "get_corrected_data() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_corrected_data", false]], "get_correlation_matrix_for_step() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.get_correlation_matrix_for_step", false]], "get_crystal_symmetry() (dxtbx.model.crystal method)": [[22, "dxtbx.model.Crystal.get_crystal_symmetry", false]], "get_data() (dials.util.image.reader method)": [[33, "dials.util.image.reader.get_data", false]], "get_data() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_data", false]], "get_detector() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_detector", false]], "get_detector() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_detector", false]], "get_detector() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_detector", false]], "get_detector() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_detector", false]], "get_detector() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.get_detector", false]], "get_detectorbase() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_detectorbase", false]], "get_direction() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_direction", false]], "get_domain_size_ang() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.get_domain_size_ang", false]], "get_elapsed_time() (dials.util.command_line.progressbartimer method)": [[33, "dials.util.command_line.ProgressBarTimer.get_elapsed_time", false]], "get_entry() (in module dials.util.nexus)": [[33, "dials.util.nexus.get_entry", false]], "get_experiments() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.get_experiments", false]], "get_fixed_rotation() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_fixed_rotation", false]], "get_format_class() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_format_class", false]], "get_format_class() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_format_class", false]], "get_free_reflections() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.get_free_reflections", false]], "get_free_reflections() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_free_reflections", false]], "get_gain() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_gain", false]], "get_gain() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_gain", false]], "get_goniometer() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_goniometer", false]], "get_goniometer() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_goniometer", false]], "get_goniometer() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_goniometer", false]], "get_goniometer() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_goniometer", false]], "get_goniometer() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.get_goniometer", false]], "get_grid_size() (dxtbx.imageset.imagegrid method)": [[26, "dxtbx.imageset.ImageGrid.get_grid_size", false]], "get_half_mosaicity_deg() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.get_half_mosaicity_deg", false]], "get_image_identifier() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_image_identifier", false]], "get_image_identifier() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_image_identifier", false]], "get_indexed() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_indexed", false]], "get_inverse_ub_matrix_from_xparm() (in module dials.util.ioutil)": [[33, "dials.util.ioutil.get_inverse_ub_matrix_from_xparm", false]], "get_kappa_angle() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_kappa_angle", false]], "get_kappa_axis() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_kappa_axis", false]], "get_mask() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_mask", false]], "get_mask() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_mask", false]], "get_master_path() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_master_path", false]], "get_matches() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.get_matches", false]], "get_matches() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_matches", false]], "get_max_inscribed_resolution() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.get_max_inscribed_resolution", false]], "get_max_resolution() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.get_max_resolution", false]], "get_mosaicity() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.get_mosaicity", false]], "get_names() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.get_names", false]], "get_names() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.get_names", false]], "get_nrows() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.get_nrows", false]], "get_num_matches() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.get_num_matches", false]], "get_num_matches_for_experiment() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.get_num_matches_for_experiment", false]], "get_num_matches_for_panel() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.get_num_matches_for_panel", false]], "get_num_scan_points() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_num_scan_points", false]], "get_num_steps() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.get_num_steps", false]], "get_obs() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_obs", false]], "get_omega_angle() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_omega_angle", false]], "get_omega_axis() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_omega_axis", false]], "get_panel_intersection() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.get_panel_intersection", false]], "get_param_reporter() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.get_param_reporter", false]], "get_parameter_correlation_matrix() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.get_parameter_correlation_matrix", false]], "get_params() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_params", false]], "get_path() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_path", false]], "get_path() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_path", false]], "get_pedestal() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_pedestal", false]], "get_phi_angle() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_phi_angle", false]], "get_phi_axis() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_phi_axis", false]], "get_raw_data() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_raw_data", false]], "get_ray_intersection() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.get_ray_intersection", false]], "get_rotation_axis() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_rotation_axis", false]], "get_rotation_axis_datum() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_rotation_axis_datum", false]], "get_sample_size() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_sample_size", false]], "get_scan() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_scan", false]], "get_scan() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_scan", false]], "get_scan() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_scan", false]], "get_scan() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_scan", false]], "get_scan() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.get_scan", false]], "get_scan_axis() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_scan_axis", false]], "get_scan_axis() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.get_scan_axis", false]], "get_setting_rotation() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_setting_rotation", false]], "get_setting_rotation_at_scan_point() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_setting_rotation_at_scan_point", false]], "get_setting_rotation_at_scan_points() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_setting_rotation_at_scan_points", false]], "get_shared_components() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.get_shared_components", false]], "get_shared_components() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.get_shared_components", false]], "get_shared_components() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.get_shared_components", false]], "get_space_group_type_from_xparm() (in module dials.util.ioutil)": [[33, "dials.util.ioutil.get_space_group_type_from_xparm", false]], "get_spectrum() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_spectrum", false]], "get_template() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_template", false]], "get_template() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_template", false]], "get_template() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.get_template", false]], "get_vendor() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_vendor", false]], "get_vendortype() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_vendortype", false]], "goniometer (class in dxtbx.model.goniometer)": [[25, "dxtbx.model.goniometer.Goniometer", false]], "goniometercomparison (class in dxtbx.model.experiment_list)": [[24, "dxtbx.model.experiment_list.GoniometerComparison", false]], "goniometerfactory (class in dxtbx.model.goniometer)": [[25, "dxtbx.model.goniometer.GoniometerFactory", false]], "goniometers() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.goniometers", false]], "gradient_threshold (dials.algorithms.refinement.engine.gaussnewtoniterations attribute)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.gradient_threshold", false]], "groups_cache() (in module dials.algorithms.indexing.symmetry)": [[11, "dials.algorithms.indexing.symmetry.groups_cache", false]], "has_dynamic_mask() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.has_dynamic_mask", false]], "has_projection_2d() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.has_projection_2d", false]], "has_single_file_reader() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.has_single_file_reader", false]], "heading() (in module dials.util.command_line)": [[33, "dials.util.command_line.heading", false]], "hierarchy() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.hierarchy", false]], "hist() (in module dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.hist", false]], "history (dials.algorithms.refinement.refiner.refiner property)": [[14, "dials.algorithms.refinement.refiner.Refiner.history", false]], "hkl_offset (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.hkl_offset", false]], "id_ (dials.algorithms.scaling.model.model.arrayscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.id_", false]], "id_ (dials.algorithms.scaling.model.model.dosedecay attribute)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.id_", false]], "id_ (dials.algorithms.scaling.model.model.kbscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.id_", false]], "id_ (dials.algorithms.scaling.model.model.physicalscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.id_", false]], "id_ (dials.algorithms.scaling.model.model.scalingmodelbase attribute)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.id_", false]], "identifiers (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.identifiers", false]], "identifiers() (dxtbx.imageset.memreader method)": [[26, "dxtbx.imageset.MemReader.identifiers", false]], "identifiers() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.identifiers", false]], "identify_outliers() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.identify_outliers", false]], "imagegrid (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageGrid", false]], "imagesequence (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageSequence", false]], "imagesequence_from_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.imagesequence_from_dict", false]], "imagesequence_to_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.imagesequence_to_dict", false]], "imageset (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageSet", false]], "imageset() (in module dxtbx.serialize.load)": [[30, "dxtbx.serialize.load.imageset", false]], "imageset_from_anyset() (dxtbx.imageset.imagesetfactory static method)": [[26, "dxtbx.imageset.ImageSetFactory.imageset_from_anyset", false]], "imageset_from_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.imageset_from_dict", false]], "imageset_to_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.imageset_to_dict", false]], "imagesetdata (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageSetData", false]], "imagesetfactory (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageSetFactory", false]], "imagesetlazy (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageSetLazy", false]], "imagesets() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.imagesets", false]], "imgcif() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.imgCIF", false]], "imgcif() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.imgCIF", false]], "imgcif() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.imgCIF", false]], "imgcif() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.imgCIF", false]], "imgcif_h() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.imgCIF_H", false]], "imgcif_h() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.imgCIF_H", false]], "imgcif_h() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.imgCIF_H", false]], "imgcif_h() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.imgCIF_H", false]], "importer (class in dials.util.options)": [[33, "dials.util.options.Importer", false]], "include_gui_packages (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.include_gui_packages", false]], "indent (dials.util.command_line.command attribute)": [[33, "dials.util.command_line.Command.indent", false]], "index() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.index", false]], "index() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.index", false]], "index_reflections() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.index_reflections", false]], "indexer (class in dials.algorithms.indexing.indexer)": [[11, "dials.algorithms.indexing.indexer.Indexer", false]], "indices() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.indices", false]], "indices() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.indices", false]], "initialise() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.initialise", false]], "initialise_smooth_input() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.initialise_smooth_input", false]], "initialize() (dials.algorithms.integration.integrator.integratorexecutor method)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor.initialize", false]], "initialize() (dials.algorithms.integration.integrator.profilemodellerexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor.initialize", false]], "initialize() (dials.algorithms.integration.integrator.profilevalidatorexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor.initialize", false]], "initialize_reflections() (dials.algorithms.integration.integrator.integrator2d static method)": [[12, "dials.algorithms.integration.integrator.Integrator2D.initialize_reflections", false]], "initialize_reflections() (dials.algorithms.integration.integrator.integrator3d static method)": [[12, "dials.algorithms.integration.integrator.Integrator3D.initialize_reflections", false]], "initialize_reflections() (dials.algorithms.integration.integrator.integratorflat3d static method)": [[12, "dials.algorithms.integration.integrator.IntegratorFlat3D.initialize_reflections", false]], "initialize_reflections() (dials.algorithms.integration.integrator.integratorsingle2d static method)": [[12, "dials.algorithms.integration.integrator.IntegratorSingle2D.initialize_reflections", false]], "initialize_reflections() (dials.algorithms.integration.integrator.integratorstills static method)": [[12, "dials.algorithms.integration.integrator.IntegratorStills.initialize_reflections", false]], "installer (class in dials.util.installer)": [[33, "dials.util.installer.installer", false]], "installer_dir (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.installer_dir", false]], "integrate() (dials.algorithms.integration.integrator.integrator method)": [[12, "dials.algorithms.integration.integrator.Integrator.integrate", false]], "integrate() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.integrate", false]], "integrator (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Integrator", false]], "integrator2d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Integrator2D", false]], "integrator3d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Integrator3D", false]], "integrator3dthreaded (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded", false]], "integratorexecutor (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor", false]], "integratorflat3d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.IntegratorFlat3D", false]], "integratorsingle2d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.IntegratorSingle2D", false]], "integratorstills (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.IntegratorStills", false]], "inv_d2() (dials.algorithms.background.radialaverage method)": [[10, "dials.algorithms.background.RadialAverage.inv_d2", false]], "invalidphilerror": [[33, "dials.util.options.InvalidPhilError", false]], "is_consistent() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.is_consistent", false]], "is_marked_for_rejection() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.is_marked_for_rejection", false]], "is_marked_for_rejection() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.is_marked_for_rejection", false]], "is_scaled (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.is_scaled", false]], "is_similar_to() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.is_similar_to", false]], "is_similar_to() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.is_similar_to", false]], "is_similar_to() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.is_similar_to", false]], "is_similar_to() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.is_similar_to", false]], "is_single_file_reader() (dxtbx.imageset.memreader static method)": [[26, "dxtbx.imageset.MemReader.is_single_file_reader", false]], "iter_levelorder() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.iter_levelorder", false]], "iter_panels() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.iter_panels", false]], "iter_preorder() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.iter_preorder", false]], "jacobian_condition_number() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.jacobian_condition_number", false]], "job() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.job", false]], "joblist (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.JobList", false]], "journal (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.Journal", false]], "kappa() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.kappa", false]], "kappagoniometer (class in dxtbx.model.goniometer)": [[25, "dxtbx.model.goniometer.KappaGoniometer", false]], "kbscalingmodel (class in dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel", false]], "kernel_normalisation() (dials.algorithms.symmetry.symmetry_base static method)": [[18, "dials.algorithms.symmetry.symmetry_base.kernel_normalisation", false]], "known_axis() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.known_axis", false]], "lauegroupanalysis (class in dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.LaueGroupAnalysis", false]], "lbfgs_with_curvs (class in dials.algorithms.symmetry.cosym.engine)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs", false]], "lbfgscurvs (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.LBFGScurvs", false]], "leastsquarespositionalresidualwithrmsdcutoff (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoff", false]], "leastsquarespositionalresidualwithrmsdcutoffsparse (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoffSparse", false]], "leastsquaresstillsresidualwithrmsdcutoff (class in dials.algorithms.refinement.target_stills)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff", false]], "leastsquaresstillsresidualwithrmsdcutoffsparse (class in dials.algorithms.refinement.target_stills)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoffSparse", false]], "levenbergmarquardtiterations (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations", false]], "limit_image_range() (dials.algorithms.scaling.model.model.arrayscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.limit_image_range", false]], "limit_image_range() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.limit_image_range", false]], "limit_image_range() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.limit_image_range", false]], "limit_image_range() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.limit_image_range", false]], "load() (in module dials.util.nexus)": [[33, "dials.util.nexus.load", false]], "load_error_model() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.load_error_model", false]], "load_image() (dials.algorithms.spot_finding.factory.spotfinderfactory static method)": [[16, "dials.algorithms.spot_finding.factory.SpotFinderFactory.load_image", false]], "log_summary() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.log_summary", false]], "lowresspotmatch (class in dials.algorithms.indexing.lattice_search)": [[11, "dials.algorithms.indexing.lattice_search.LowResSpotMatch", false]], "madmergedmtzwriter (class in dials.util.export_mtz)": [[33, "dials.util.export_mtz.MADMergedMTZWriter", false]], "make_apps (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.make_apps", false]], "make_beam() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.make_beam", false]], "make_combined_plots() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.make_combined_plots", false]], "make_detector() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.make_detector", false]], "make_goniometer() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.make_goniometer", false]], "make_imageset() (dxtbx.imageset.imagesetfactory static method)": [[26, "dxtbx.imageset.ImageSetFactory.make_imageset", false]], "make_kappa_goniometer() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.make_kappa_goniometer", false]], "make_multi_axis_goniometer() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.make_multi_axis_goniometer", false]], "make_polarized_beam() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.make_polarized_beam", false]], "make_polychromatic_beam() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.make_polychromatic_beam", false]], "make_scan() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.make_scan", false]], "make_scan_from_properties() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.make_scan_from_properties", false]], "make_sequence() (dxtbx.imageset.imagesetfactory static method)": [[26, "dxtbx.imageset.ImageSetFactory.make_sequence", false]], "mark_for_rejection() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.mark_for_rejection", false]], "mark_for_rejection() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.mark_for_rejection", false]], "mask (dxtbx.imageset.externallookup property)": [[26, "dxtbx.imageset.ExternalLookup.mask", false]], "masker() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.masker", false]], "masker() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.masker", false]], "master_path() (dxtbx.imageset.memreader static method)": [[26, "dxtbx.imageset.MemReader.master_path", false]], "match_wavelengths() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.match_wavelengths", false]], "max_length (dials.util.command_line.command attribute)": [[33, "dials.util.command_line.Command.max_length", false]], "max_possible_wl (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.max_possible_wl", false]], "max_shift_over_esd (dials.algorithms.refinement.engine.gaussnewtoniterations attribute)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.max_shift_over_esd", false]], "mean() (dials.algorithms.background.radialaverage method)": [[10, "dials.algorithms.background.RadialAverage.mean", false]], "median_unit_cell() (in module dials.algorithms.symmetry)": [[18, "dials.algorithms.symmetry.median_unit_cell", false]], "memreader (class in dxtbx.imageset)": [[26, "dxtbx.imageset.MemReader", false]], "merge_panel_scope_extracts_by_id() (in module dxtbx.model.detector)": [[23, "dxtbx.model.detector.merge_panel_scope_extracts_by_id", false]], "mergedmtzwriter (class in dials.util.export_mtz)": [[33, "dials.util.export_mtz.MergedMTZWriter", false]], "message (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.message", false]], "metric_supergroup() (in module dials.algorithms.indexing.symmetry)": [[11, "dials.algorithms.indexing.symmetry.metric_supergroup", false]], "min_wl (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.min_wl", false]], "minimize_scipy() (in module dials.algorithms.symmetry.cosym.engine)": [[18, "dials.algorithms.symmetry.cosym.engine.minimize_scipy", false]], "minimize_scitbx_lbfgs() (in module dials.algorithms.symmetry.cosym.engine)": [[18, "dials.algorithms.symmetry.cosym.engine.minimize_scitbx_lbfgs", false]], "ml_aniso_normalisation() (dials.algorithms.symmetry.symmetry_base static method)": [[18, "dials.algorithms.symmetry.symmetry_base.ml_aniso_normalisation", false]], "ml_iso_normalisation() (dials.algorithms.symmetry.symmetry_base static method)": [[18, "dials.algorithms.symmetry.symmetry_base.ml_iso_normalisation", false]], "model_likelihood (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.model_likelihood", false]], "modelevaluation (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.ModelEvaluation", false]], "modelrank (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRank", false]], "modelrankfilter (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter", false]], "modelrankweighted (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted", false]], "module": [[10, "module-dials.algorithms.background", false], [11, "module-dials.algorithms.indexing", false], [11, "module-dials.algorithms.indexing.assign_indices", false], [11, "module-dials.algorithms.indexing.basis_vector_search", false], [11, "module-dials.algorithms.indexing.basis_vector_search.combinations", false], [11, "module-dials.algorithms.indexing.basis_vector_search.optimise", false], [11, "module-dials.algorithms.indexing.compare_orientation_matrices", false], [11, "module-dials.algorithms.indexing.indexer", false], [11, "module-dials.algorithms.indexing.lattice_search", false], [11, "module-dials.algorithms.indexing.max_cell", false], [11, "module-dials.algorithms.indexing.model_evaluation", false], [11, "module-dials.algorithms.indexing.nearest_neighbor", false], [11, "module-dials.algorithms.indexing.refinement", false], [11, "module-dials.algorithms.indexing.stills_indexer", false], [11, "module-dials.algorithms.indexing.symmetry", false], [12, "module-dials.algorithms.integration.integrator", false], [13, "module-dials.algorithms.profile_model", false], [14, "module-dials.algorithms.refinement.engine", false], [14, "module-dials.algorithms.refinement.refiner", false], [14, "module-dials.algorithms.refinement.reflection_manager", false], [14, "module-dials.algorithms.refinement.target", false], [14, "module-dials.algorithms.refinement.target_stills", false], [14, "module-dials.algorithms.refinement.weighting_strategies", false], [15, "module-dials.algorithms.scaling", false], [15, "module-dials.algorithms.scaling.model.model", false], [15, "module-dials.algorithms.scaling.outlier_rejection", false], [16, "module-dials.algorithms.spot_finding.factory", false], [16, "module-dials.algorithms.spot_finding.finder", false], [17, "module-dials.algorithms.spot_prediction.reflection_predictor", false], [18, "module-dials.algorithms.symmetry", false], [18, "module-dials.algorithms.symmetry.cosym", false], [18, "module-dials.algorithms.symmetry.cosym.engine", false], [18, "module-dials.algorithms.symmetry.cosym.target", false], [18, "module-dials.algorithms.symmetry.laue_group", false], [18, "module-dials.algorithms.symmetry.reindex_to_reference", false], [20, "module-dials.array_family.flex", false], [21, "module-dxtbx.model.beam", false], [22, "module-dxtbx.model.crystal", false], [23, "module-dxtbx.model.detector", false], [24, "module-dxtbx.model.experiment_list", false], [25, "module-dxtbx.model.goniometer", false], [26, "module-dxtbx.imageset", false], [28, "module-dxtbx.model.profile", false], [29, "module-dxtbx.model.scan", false], [30, "module-dxtbx.serialize.imageset", false], [30, "module-dxtbx.serialize.load", false], [30, "module-dxtbx.serialize.xds", false], [31, "module-dials.extensions.dispersion_spotfinder_threshold_ext", false], [31, "module-dials.extensions.gaussian_rs_profile_model_ext", false], [31, "module-dials.extensions.null_background_ext", false], [31, "module-dials.extensions.simple_background_ext", false], [31, "module-dials.extensions.simple_centroid_ext", false], [33, "module-dials.util.command_line", false], [33, "module-dials.util.export_mtz", false], [33, "module-dials.util.export_text", false], [33, "module-dials.util.image", false], [33, "module-dials.util.installer", false], [33, "module-dials.util.ioutil", false], [33, "module-dials.util.nexus", false], [33, "module-dials.util.options", false]], "mosaiccrystalkabsch2010 (class in dxtbx.model)": [[22, "dxtbx.model.MosaicCrystalKabsch2010", false]], "mosaiccrystalsauter2014 (class in dxtbx.model)": [[22, "dxtbx.model.MosaicCrystalSauter2014", false]], "mtzwriterbase (class in dials.util.export_mtz)": [[33, "dials.util.export_mtz.MTZWriterBase", false]], "mu (dials.algorithms.refinement.engine.levenbergmarquardtiterations property)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.mu", false]], "multi_axis() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.multi_axis", false]], "multi_axis_goniometer_from_phil() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.multi_axis_goniometer_from_phil", false]], "multiaxisgoniometer (class in dxtbx.model.goniometer)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer", false]], "n() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.n", false]], "n_indexed (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.n_indexed", false]], "n_params (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.n_params", false]], "name (dials.extensions.dispersion_spotfinder_threshold_ext.dispersionspotfinderthresholdext attribute)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt.name", false]], "name (dials.extensions.gaussian_rs_profile_model_ext.gaussianrsprofilemodelext attribute)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt.name", false]], "name (dials.extensions.null_background_ext.nullbackgroundext attribute)": [[31, "dials.extensions.null_background_ext.NullBackgroundExt.name", false]], "name (dials.extensions.simple_background_ext.simplebackgroundext attribute)": [[31, "dials.extensions.simple_background_ext.SimpleBackgroundExt.name", false]], "name (dials.extensions.simple_centroid_ext.simplecentroidext attribute)": [[31, "dials.extensions.simple_centroid_ext.SimpleCentroidExt.name", false]], "name (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.name", false]], "neighboranalysis (class in dials.algorithms.indexing.nearest_neighbor)": [[11, "dials.algorithms.indexing.nearest_neighbor.NeighborAnalysis", false]], "new() (dxtbx.imageset.imagesetfactory static method)": [[26, "dxtbx.imageset.ImageSetFactory.new", false]], "nframes_hist() (in module dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.nframes_hist", false]], "normdevoutlierrejection (class in dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.NormDevOutlierRejection", false]], "nullbackgroundext (class in dials.extensions.null_background_ext)": [[31, "dials.extensions.null_background_ext.NullBackgroundExt", false]], "nullify_all_single_file_reader_format_instances() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.nullify_all_single_file_reader_format_instances", false]], "num_reflections() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.num_reflections", false]], "num_scan_points (dxtbx.model.goniometer.goniometer property)": [[25, "dxtbx.model.goniometer.Goniometer.num_scan_points", false]], "numerator() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.numerator", false]], "optimise_basis_vectors() (in module dials.algorithms.indexing.basis_vector_search.optimise)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.optimise_basis_vectors", false]], "optionparser (class in dials.util.options)": [[33, "dials.util.options.OptionParser", false]], "outlierrejectionbase (class in dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.OutlierRejectionBase", false]], "overwrite_from_phil() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.overwrite_from_phil", false]], "p_cc_given_not_s (dials.algorithms.symmetry.laue_group.scorecorrelationcoefficient property)": [[18, "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient.p_cc_given_not_s", false]], "p_cc_given_s (dials.algorithms.symmetry.laue_group.scorecorrelationcoefficient property)": [[18, "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient.p_cc_given_s", false]], "p_s_given_cc (dials.algorithms.symmetry.laue_group.scorecorrelationcoefficient property)": [[18, "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient.p_s_given_cc", false]], "parameter_vector_norm() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.parameter_vector_norm", false]], "parameters (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Parameters", false]], "parameters.filter (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Parameters.Filter", false]], "parameters.profile (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Parameters.Profile", false]], "parameters.profile.validation (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Parameters.Profile.Validation", false]], "params() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.params", false]], "parse_args() (dials.util.options.argumentparser method)": [[33, "dials.util.options.ArgumentParser.parse_args", false]], "parse_args() (dials.util.options.philcommandparser method)": [[33, "dials.util.options.PhilCommandParser.parse_args", false]], "parse_known_args() (dials.util.options.argumentparserbase method)": [[33, "dials.util.options.ArgumentParserBase.parse_known_args", false]], "partial_data() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.partial_data", false]], "partial_set() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.partial_set", false]], "partial_set() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.partial_set", false]], "paths() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.paths", false]], "paths() (dxtbx.imageset.memreader method)": [[26, "dxtbx.imageset.MemReader.paths", false]], "peakcentroiddistancefilter (class in dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.PeakCentroidDistanceFilter", false]], "pedestal (dxtbx.imageset.externallookup property)": [[26, "dxtbx.imageset.ExternalLookup.pedestal", false]], "per_image() (dials.algorithms.refinement.reflection_manager.blockcalculator method)": [[14, "dials.algorithms.refinement.reflection_manager.BlockCalculator.per_image", false]], "per_width() (dials.algorithms.refinement.reflection_manager.blockcalculator method)": [[14, "dials.algorithms.refinement.reflection_manager.BlockCalculator.per_width", false]], "phil (dials.util.options.argumentparser property)": [[33, "dials.util.options.ArgumentParser.phil", false]], "phil (dials.util.options.philcommandparser property)": [[33, "dials.util.options.PhilCommandParser.phil", false]], "phil() (dials.extensions.dispersion_spotfinder_threshold_ext.dispersionspotfinderthresholdext static method)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt.phil", false]], "phil() (dials.extensions.gaussian_rs_profile_model_ext.gaussianrsprofilemodelext static method)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt.phil", false]], "phil() (dials.extensions.simple_background_ext.simplebackgroundext static method)": [[31, "dials.extensions.simple_background_ext.SimpleBackgroundExt.phil", false]], "phil_help (dials.algorithms.indexing.basis_vector_search.fft1d attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT1D.phil_help", false]], "phil_help (dials.algorithms.indexing.basis_vector_search.fft3d attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT3D.phil_help", false]], "phil_help (dials.algorithms.indexing.basis_vector_search.realspacegridsearch attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.phil_help", false]], "phil_help (dials.algorithms.indexing.basis_vector_search.strategy attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.Strategy.phil_help", false]], "phil_help (dials.algorithms.indexing.lattice_search.lowresspotmatch attribute)": [[11, "dials.algorithms.indexing.lattice_search.LowResSpotMatch.phil_help", false]], "phil_help (dials.algorithms.indexing.lattice_search.pinkindexer attribute)": [[11, "dials.algorithms.indexing.lattice_search.PinkIndexer.phil_help", false]], "phil_help (dials.algorithms.indexing.lattice_search.strategy attribute)": [[11, "dials.algorithms.indexing.lattice_search.Strategy.phil_help", false]], "phil_scope (dials.algorithms.indexing.basis_vector_search.fft1d attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT1D.phil_scope", false]], "phil_scope (dials.algorithms.indexing.basis_vector_search.fft3d attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT3D.phil_scope", false]], "phil_scope (dials.algorithms.indexing.basis_vector_search.realspacegridsearch attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.phil_scope", false]], "phil_scope (dials.algorithms.indexing.basis_vector_search.strategy attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.Strategy.phil_scope", false]], "phil_scope (dials.algorithms.indexing.lattice_search.lowresspotmatch attribute)": [[11, "dials.algorithms.indexing.lattice_search.LowResSpotMatch.phil_scope", false]], "phil_scope (dials.algorithms.indexing.lattice_search.pinkindexer attribute)": [[11, "dials.algorithms.indexing.lattice_search.PinkIndexer.phil_scope", false]], "phil_scope (dials.algorithms.indexing.lattice_search.strategy attribute)": [[11, "dials.algorithms.indexing.lattice_search.Strategy.phil_scope", false]], "phil_scope (dials.algorithms.scaling.model.model.arrayscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.phil_scope", false]], "phil_scope (dials.algorithms.scaling.model.model.dosedecay attribute)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.phil_scope", false]], "phil_scope (dials.algorithms.scaling.model.model.kbscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.phil_scope", false]], "phil_scope (dials.algorithms.scaling.model.model.physicalscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.phil_scope", false]], "philcommandparser (class in dials.util.options)": [[33, "dials.util.options.PhilCommandParser", false]], "physicalscalingmodel (class in dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel", false]], "pinkindexer (class in dials.algorithms.indexing.lattice_search)": [[11, "dials.algorithms.indexing.lattice_search.PinkIndexer", false]], "pixel_list_to_reflection_table() (in module dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.pixel_list_to_reflection_table", false]], "pixel_list_to_shoeboxes() (in module dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.pixel_list_to_shoeboxes", false]], "plot_displacements() (in module dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.plot_displacements", false]], "plot_histogram() (dials.algorithms.indexing.nearest_neighbor.neighboranalysis method)": [[11, "dials.algorithms.indexing.nearest_neighbor.NeighborAnalysis.plot_histogram", false]], "plot_model_components() (dials.algorithms.scaling.model.model.arrayscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.plot_model_components", false]], "plot_model_components() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.plot_model_components", false]], "plot_model_components() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.plot_model_components", false]], "plot_model_components() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.plot_model_components", false]], "plot_scaling_models() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.plot_scaling_models", false]], "predict() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.predict", false]], "predict_for_free_reflections() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.predict_for_free_reflections", false]], "predict_for_indexed() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.predict_for_indexed", false]], "predict_for_reflection_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.predict_for_reflection_table", false]], "predict_for_reflection_table() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.predict_for_reflection_table", false]], "predict_for_reflection_table() (dials.algorithms.refinement.target_stills.leastsquaresstillsresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff.predict_for_reflection_table", false]], "predictor() (dials.algorithms.spot_prediction.reflection_predictor.reflectionpredictor method)": [[17, "dials.algorithms.spot_prediction.reflection_predictor.ReflectionPredictor.predictor", false]], "prepare_for_step() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.prepare_for_step", false]], "print_exp_rmsd_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.print_exp_rmsd_table", false]], "print_out_of_sample_rmsd_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.print_out_of_sample_rmsd_table", false]], "print_panel_rmsd_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.print_panel_rmsd_table", false]], "print_stats_on_matches() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.print_stats_on_matches", false]], "print_stats_on_matches() (dials.algorithms.refinement.reflection_manager.stillsreflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.StillsReflectionManager.print_stats_on_matches", false]], "print_step_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.print_step_table", false]], "print_time (dials.util.command_line.command attribute)": [[33, "dials.util.command_line.Command.print_time", false]], "process() (dials.algorithms.integration.integrator.executor method)": [[12, "dials.algorithms.integration.integrator.Executor.process", false]], "process() (dials.algorithms.integration.integrator.integratorexecutor method)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor.process", false]], "process() (dials.algorithms.integration.integrator.profilemodellerexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor.process", false]], "process() (dials.algorithms.integration.integrator.profilevalidatorexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor.process", false]], "processor2d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Processor2D", false]], "processor3d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Processor3D", false]], "processorclass (dials.algorithms.integration.integrator.integrator2d attribute)": [[12, "dials.algorithms.integration.integrator.Integrator2D.ProcessorClass", false]], "processorclass (dials.algorithms.integration.integrator.integrator3d attribute)": [[12, "dials.algorithms.integration.integrator.Integrator3D.ProcessorClass", false]], "processorclass (dials.algorithms.integration.integrator.integratorflat3d attribute)": [[12, "dials.algorithms.integration.integrator.IntegratorFlat3D.ProcessorClass", false]], "processorclass (dials.algorithms.integration.integrator.integratorsingle2d attribute)": [[12, "dials.algorithms.integration.integrator.IntegratorSingle2D.ProcessorClass", false]], "processorclass (dials.algorithms.integration.integrator.integratorstills attribute)": [[12, "dials.algorithms.integration.integrator.IntegratorStills.ProcessorClass", false]], "processorflat3d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ProcessorFlat3D", false]], "processorsingle2d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ProcessorSingle2D", false]], "processorstills (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ProcessorStills", false]], "product_name (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.product_name", false]], "product_specific_finalize_install() (dials.util.installer.installer method)": [[33, "dials.util.installer.installer.product_specific_finalize_install", false]], "profilemodelfactory (class in dxtbx.model.profile)": [[28, "dxtbx.model.profile.ProfileModelFactory", false]], "profilemodellerexecutor (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor", false]], "profiles() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.profiles", false]], "profilevalidatorexecutor (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor", false]], "progressbar (class in dials.util.command_line)": [[33, "dials.util.command_line.ProgressBar", false]], "progressbartimer (class in dials.util.command_line)": [[33, "dials.util.command_line.ProgressBarTimer", false]], "radialaverage (class in dials.algorithms.background)": [[10, "dials.algorithms.background.RadialAverage", false]], "read() (dxtbx.imageset.memreader method)": [[26, "dxtbx.imageset.MemReader.read", false]], "read_file() (dials.util.image.reader method)": [[33, "dials.util.image.reader.read_file", false]], "reader (class in dials.util.image)": [[33, "dials.util.image.reader", false]], "reader() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.reader", false]], "reader() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.reader", false]], "realspacegridsearch (class in dials.algorithms.indexing.basis_vector_search)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch", false]], "reason_for_termination (dials.algorithms.refinement.engine.journal attribute)": [[14, "dials.algorithms.refinement.engine.Journal.reason_for_termination", false]], "record_intensity_combination_imid() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.record_intensity_combination_Imid", false]], "refine() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.refine", false]], "refine() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.refine", false]], "refine() (in module dials.algorithms.indexing.refinement)": [[11, "dials.algorithms.indexing.refinement.refine", false]], "refiner (class in dials.algorithms.refinement.refiner)": [[14, "dials.algorithms.refinement.refiner.Refiner", false]], "refinerfactory (class in dials.algorithms.refinement.refiner)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory", false]], "refinery (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.Refinery", false]], "reflectionmanager (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ReflectionManager", false]], "reflectionmanager (class in dials.algorithms.refinement.reflection_manager)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager", false]], "reflectionmanagerfactory (class in dials.algorithms.refinement.reflection_manager)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManagerFactory", false]], "reflectionpredictor (class in dials.algorithms.spot_prediction.reflection_predictor)": [[17, "dials.algorithms.spot_prediction.reflection_predictor.ReflectionPredictor", false]], "reflections_after_outlier_rejection() (dials.algorithms.refinement.refiner.refinerfactory class method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.reflections_after_outlier_rejection", false]], "reflections_and_experiments_from_files() (in module dials.util.options)": [[33, "dials.util.options.reflections_and_experiments_from_files", false]], "reject_outliers() (in module dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.reject_outliers", false]], "remove_on_experiment_identifiers() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.remove_on_experiment_identifiers", false]], "remove_sources_default (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.remove_sources_default", false]], "replace() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.replace", false]], "report() (dials.algorithms.integration.integrator.integrator method)": [[12, "dials.algorithms.integration.integrator.Integrator.report", false]], "report() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.report", false]], "report_progress() (dials.algorithms.refinement.engine.levenbergmarquardtiterations method)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.report_progress", false]], "reset_accepted_reflections() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.reset_accepted_reflections", false]], "reset_scan_points() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.reset_scan_points", false]], "resolution_filter_from_array() (in module dials.algorithms.symmetry)": [[18, "dials.algorithms.symmetry.resolution_filter_from_array", false]], "resolution_filter_from_reflections_experiments() (in module dials.algorithms.symmetry)": [[18, "dials.algorithms.symmetry.resolution_filter_from_reflections_experiments", false]], "restart() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.restart", false]], "result (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.Result", false]], "rmsd_names (dials.algorithms.refinement.target.target attribute)": [[14, "dials.algorithms.refinement.target.Target.rmsd_names", false]], "rmsd_names (dials.algorithms.refinement.target_stills.leastsquaresstillsresidualwithrmsdcutoff attribute)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff.rmsd_names", false]], "rmsd_units (dials.algorithms.refinement.target.target attribute)": [[14, "dials.algorithms.refinement.target.Target.rmsd_units", false]], "rmsd_units (dials.algorithms.refinement.target_stills.leastsquaresstillsresidualwithrmsdcutoff attribute)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff.rmsd_units", false]], "rmsds (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.rmsds", false]], "rmsds() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.rmsds", false]], "rmsds() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.rmsds", false]], "rmsds_for_experiment() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.rmsds_for_experiment", false]], "rmsds_for_panel() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.rmsds_for_panel", false]], "rmsds_for_reflection_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.rmsds_for_reflection_table", false]], "rmsds_for_reflection_table() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.rmsds_for_reflection_table", false]], "rotate_around_origin() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.rotate_around_origin", false]], "rotate_around_origin() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.rotate_around_origin", false]], "rotate_crystal() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.rotate_crystal", false]], "rotation_matrix_differences() (in module dials.algorithms.indexing.compare_orientation_matrices)": [[11, "dials.algorithms.indexing.compare_orientation_matrices.rotation_matrix_differences", false]], "run() (dials.algorithms.refinement.engine.gaussnewtoniterations method)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.run", false]], "run() (dials.algorithms.refinement.engine.lbfgscurvs method)": [[14, "dials.algorithms.refinement.engine.LBFGScurvs.run", false]], "run() (dials.algorithms.refinement.engine.levenbergmarquardtiterations method)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.run", false]], "run() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.run", false]], "run() (dials.algorithms.refinement.engine.simplelbfgs method)": [[14, "dials.algorithms.refinement.engine.SimpleLBFGS.run", false]], "run() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.run", false]], "run() (dials.algorithms.scaling.outlier_rejection.outlierrejectionbase method)": [[15, "dials.algorithms.scaling.outlier_rejection.OutlierRejectionBase.run", false]], "run() (dials.algorithms.spot_finding.factory.backgroundgradientfilter method)": [[16, "dials.algorithms.spot_finding.factory.BackgroundGradientFilter.run", false]], "run() (dials.algorithms.spot_finding.factory.peakcentroiddistancefilter method)": [[16, "dials.algorithms.spot_finding.factory.PeakCentroidDistanceFilter.run", false]], "run() (dials.algorithms.spot_finding.factory.spotdensityfilter method)": [[16, "dials.algorithms.spot_finding.factory.SpotDensityFilter.run", false]], "run() (dials.algorithms.symmetry.cosym.cosymanalysis method)": [[18, "dials.algorithms.symmetry.cosym.CosymAnalysis.run", false]], "run_lbfgs() (dials.algorithms.refinement.engine.adaptlbfgs method)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs.run_lbfgs", false]], "scaling_models() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.scaling_models", false]], "scalingmodelbase (class in dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase", false]], "scanfactory (class in dxtbx.model.scan)": [[29, "dxtbx.model.scan.ScanFactory", false]], "scans() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.scans", false]], "scanvaryingrefiner (class in dials.algorithms.refinement.refiner)": [[14, "dials.algorithms.refinement.refiner.ScanVaryingRefiner", false]], "score_by_fraction_indexed() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.score_by_fraction_indexed", false]], "score_by_rmsd_xy() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.score_by_rmsd_xy", false]], "score_by_volume() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.score_by_volume", false]], "score_vectors() (dials.algorithms.indexing.basis_vector_search.realspacegridsearch method)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.score_vectors", false]], "scorecorrelationcoefficient (class in dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient", false]], "scoresubgroup (class in dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.ScoreSubGroup", false]], "scoresubgroup (class in dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSubGroup", false]], "scoresymmetryelement (class in dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.ScoreSymmetryElement", false]], "scoresymmetryelement (class in dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSymmetryElement", false]], "search() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.search", false]], "search_directions (dials.algorithms.indexing.basis_vector_search.realspacegridsearch property)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.search_directions", false]], "search_vectors (dials.algorithms.indexing.basis_vector_search.realspacegridsearch property)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.search_vectors", false]], "select_on_experiment_identifiers() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.select_on_experiment_identifiers", false]], "selection_used_for_refinement() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.selection_used_for_refinement", false]], "sensor() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.sensor", false]], "set_angles() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.set_angles", false]], "set_axes() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.set_axes", false]], "set_beam() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.set_beam", false]], "set_beam() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.set_beam", false]], "set_beam() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_beam", false]], "set_cholesky_factor() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.set_cholesky_factor", false]], "set_detector() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.set_detector", false]], "set_detector() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.set_detector", false]], "set_detector() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_detector", false]], "set_dimensions() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.set_dimensions", false]], "set_domain_size_ang() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.set_domain_size_ang", false]], "set_error_model() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.set_error_model", false]], "set_fixed_rotation() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.set_fixed_rotation", false]], "set_format_class() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_format_class", false]], "set_goniometer() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.set_goniometer", false]], "set_goniometer() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.set_goniometer", false]], "set_goniometer() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_goniometer", false]], "set_half_mosaicity_deg() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.set_half_mosaicity_deg", false]], "set_last_cell() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.set_last_cell", false]], "set_mosaicity() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.set_mosaicity", false]], "set_nproc() (dials.algorithms.refinement.engine.disablempmixin method)": [[14, "dials.algorithms.refinement.engine.DisableMPmixin.set_nproc", false]], "set_nproc() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.set_nproc", false]], "set_params() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_params", false]], "set_rotation_axis() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.set_rotation_axis", false]], "set_rotation_axis_datum() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.set_rotation_axis_datum", false]], "set_scaling_model_as_scaled() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.set_scaling_model_as_scaled", false]], "set_scaling_model_as_unscaled() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.set_scaling_model_as_unscaled", false]], "set_scan() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.set_scan", false]], "set_scan() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.set_scan", false]], "set_scan() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_scan", false]], "set_setting_rotation() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.set_setting_rotation", false]], "set_setting_rotation_at_scan_points() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.set_setting_rotation_at_scan_points", false]], "set_shoebox_background_value() (in module dials.algorithms.background)": [[10, "dials.algorithms.background.set_shoebox_background_value", false]], "set_template() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_template", false]], "set_valid_image_range() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.set_valid_image_range", false]], "set_vendor() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_vendor", false]], "setup_indexing() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.setup_indexing", false]], "setup_mu() (dials.algorithms.refinement.engine.levenbergmarquardtiterations method)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.setup_mu", false]], "shoebox_memory() (dials.algorithms.integration.integrator.joblist method)": [[12, "dials.algorithms.integration.integrator.JobList.shoebox_memory", false]], "shoeboxes_to_reflection_table() (in module dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.shoeboxes_to_reflection_table", false]], "show() (dxtbx.model.crystal method)": [[22, "dxtbx.model.Crystal.show", false]], "show_experiments() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.show_experiments", false]], "simple() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.simple", false]], "simple() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.simple", false]], "simple_directional() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.simple_directional", false]], "simplebackgroundext (class in dials.extensions.simple_background_ext)": [[31, "dials.extensions.simple_background_ext.SimpleBackgroundExt", false]], "simplecentroidext (class in dials.extensions.simple_centroid_ext)": [[31, "dials.extensions.simple_centroid_ext.SimpleCentroidExt", false]], "simplelbfgs (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.SimpleLBFGS", false]], "simplenormdevoutlierrejection (class in dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.SimpleNormDevOutlierRejection", false]], "single_axis() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.single_axis", false]], "single_axis_goniometer_from_phil() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.single_axis_goniometer_from_phil", false]], "single_axis_reverse() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.single_axis_reverse", false]], "single_file() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.single_file", false]], "size() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.size", false]], "source_packages (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.source_packages", false]], "sparsegradientsmixin (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.SparseGradientsMixin", false]], "split() (dials.algorithms.integration.integrator.joblist method)": [[12, "dials.algorithms.integration.integrator.JobList.split", false]], "split() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.split", false]], "split_jacobian_into_blocks() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.split_jacobian_into_blocks", false]], "split_matches_into_blocks() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.split_matches_into_blocks", false]], "spotdensityfilter (class in dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.SpotDensityFilter", false]], "spotfinder (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.SpotFinder", false]], "spotfinderfactory (class in dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.SpotFinderFactory", false]], "stars (dials.algorithms.symmetry.cosym.scoresubgroup property)": [[18, "dials.algorithms.symmetry.cosym.ScoreSubGroup.stars", false]], "stars (dials.algorithms.symmetry.cosym.scoresymmetryelement property)": [[18, "dials.algorithms.symmetry.cosym.ScoreSymmetryElement.stars", false]], "start() (dials.util.command_line.command class method)": [[33, "dials.util.command_line.Command.start", false]], "statisticalweightingstrategy (class in dials.algorithms.refinement.weighting_strategies)": [[14, "dials.algorithms.refinement.weighting_strategies.StatisticalWeightingStrategy", false]], "step_backward() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.step_backward", false]], "step_forward() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.step_forward", false]], "step_threshold (dials.algorithms.refinement.engine.gaussnewtoniterations attribute)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.step_threshold", false]], "stillsindexer (class in dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer", false]], "stillsindexerbasisvectorsearch (class in dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexerBasisVectorSearch", false]], "stillsindexerknownorientation (class in dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexerKnownOrientation", false]], "stillsindexerlatticesearch (class in dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexerLatticeSearch", false]], "stillsreflectionmanager (class in dials.algorithms.refinement.reflection_manager)": [[14, "dials.algorithms.refinement.reflection_manager.StillsReflectionManager", false]], "stillsweightingstrategy (class in dials.algorithms.refinement.weighting_strategies)": [[14, "dials.algorithms.refinement.weighting_strategies.StillsWeightingStrategy", false]], "strategy (class in dials.algorithms.indexing.basis_vector_search)": [[11, "dials.algorithms.indexing.basis_vector_search.Strategy", false]], "strategy (class in dials.algorithms.indexing.lattice_search)": [[11, "dials.algorithms.indexing.lattice_search.Strategy", false]], "strategy (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.Strategy", false]], "subgroups_table() (dials.algorithms.symmetry.cosym.symmetryanalysis static method)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis.subgroups_table", false]], "summary() (dials.algorithms.integration.integrator.integrator method)": [[12, "dials.algorithms.integration.integrator.Integrator.summary", false]], "summary() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.summary", false]], "summary_table() (dials.algorithms.symmetry.cosym.symmetryanalysis static method)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis.summary_table", false]], "sym_ops_table() (dials.algorithms.symmetry.cosym.symmetryanalysis static method)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis.sym_ops_table", false]], "symmetry_base (class in dials.algorithms.symmetry)": [[18, "dials.algorithms.symmetry.symmetry_base", false]], "symmetryanalysis (class in dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis", false]], "symmetryhandler (class in dials.algorithms.indexing.symmetry)": [[11, "dials.algorithms.indexing.symmetry.SymmetryHandler", false]], "system_phil (dials.util.options.argumentparser property)": [[33, "dials.util.options.ArgumentParser.system_phil", false]], "system_phil (dials.util.options.philcommandparser property)": [[33, "dials.util.options.PhilCommandParser.system_phil", false]], "target (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.Target", false]], "target (class in dials.algorithms.symmetry.cosym.target)": [[18, "dials.algorithms.symmetry.cosym.target.Target", false]], "targetedoutlierrejection (class in dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.TargetedOutlierRejection", false]], "targetfactory (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.TargetFactory", false]], "tau (dials.algorithms.refinement.engine.levenbergmarquardtiterations attribute)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.tau", false]], "test_for_termination() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.test_for_termination", false]], "test_objective_increasing_but_not_nref() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.test_objective_increasing_but_not_nref", false]], "test_rmsd_convergence() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.test_rmsd_convergence", false]], "to_crystal() (in module dxtbx.serialize.xds)": [[30, "dxtbx.serialize.xds.to_crystal", false]], "to_dict() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.to_dict", false]], "to_dict() (dxtbx.model.crystal method)": [[22, "dxtbx.model.Crystal.to_dict", false]], "to_dict() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.to_dict", false]], "to_dict() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.to_dict", false]], "to_dict() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.to_dict", false]], "to_dict() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.to_dict", false]], "to_dict() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.to_dict", false]], "to_dict() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.to_dict", false]], "to_imageset() (in module dxtbx.serialize.xds)": [[30, "dxtbx.serialize.xds.to_imageset", false]], "to_json_file() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.to_json_file", false]], "to_xds (class in dxtbx.serialize.xds)": [[30, "dxtbx.serialize.xds.to_xds", false]], "tofspotfinder (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.TOFSpotFinder", false]], "traceback (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.traceback", false]], "trunccauchy_pdf() (in module dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.trunccauchy_pdf", false]], "try_read_experiments() (dials.util.options.importer method)": [[33, "dials.util.options.Importer.try_read_experiments", false]], "try_read_experiments_from_images() (dials.util.options.importer method)": [[33, "dials.util.options.Importer.try_read_experiments_from_images", false]], "try_read_reflections() (dials.util.options.importer method)": [[33, "dials.util.options.Importer.try_read_reflections", false]], "two_theta() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.two_theta", false]], "type (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.type", false]], "update() (dials.algorithms.scaling.model.model.arrayscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.update", false]], "update() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.update", false]], "update() (dials.algorithms.scaling.model.model.kbscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.update", false]], "update() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.update", false]], "update() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.update", false]], "update() (dials.util.command_line.progressbar method)": [[33, "dials.util.command_line.ProgressBar.update", false]], "update() (dials.util.command_line.progressbartimer method)": [[33, "dials.util.command_line.ProgressBarTimer.update", false]], "update_analysis() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.update_analysis", false]], "update_detector_px_mm_data() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.update_detector_px_mm_data", false]], "update_detector_px_mm_data() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.update_detector_px_mm_data", false]], "update_journal() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.update_journal", false]], "update_matches() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.update_matches", false]], "validation (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.validation", false]], "warn_if_setting_unused_refinement_protocol_params() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.warn_if_setting_unused_refinement_protocol_params", false]], "wavelengthgroup (class in dials.util.export_mtz)": [[33, "dials.util.export_mtz.WavelengthGroup", false]], "wavelengths (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.wavelengths", false]], "weight() (dials.algorithms.background.radialaverage method)": [[10, "dials.algorithms.background.RadialAverage.weight", false]], "weighted_mean (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.weighted_mean", false]], "where() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.where", false]], "write_columns() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.write_columns", false]], "xds_detector_name() (in module dxtbx.serialize.xds)": [[30, "dxtbx.serialize.xds.xds_detector_name", false]], "xds_inp() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.XDS_INP", false]], "xparm_xds() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.xparm_xds", false]]}, "objects": {"dials.algorithms": [[10, 0, 0, "-", "background"], [11, 0, 0, "-", "indexing"], [13, 0, 0, "-", "profile_model"], [15, 0, 0, "-", "scaling"], [18, 0, 0, "-", "symmetry"]], "dials.algorithms.background": [[10, 1, 1, "", "RadialAverage"], [10, 3, 1, "", "set_shoebox_background_value"]], "dials.algorithms.background.RadialAverage": [[10, 2, 1, "", "__init__"], [10, 2, 1, "", "add"], [10, 2, 1, "", "inv_d2"], [10, 2, 1, "", "mean"], [10, 2, 1, "", "weight"]], "dials.algorithms.indexing": [[11, 4, 1, "", "DialsIndexError"], [11, 4, 1, "", "DialsIndexRefineError"], [11, 0, 0, "-", "assign_indices"], [11, 0, 0, "-", "basis_vector_search"], [11, 0, 0, "-", "compare_orientation_matrices"], [11, 0, 0, "-", "indexer"], [11, 0, 0, "-", "lattice_search"], [11, 0, 0, "-", "max_cell"], [11, 0, 0, "-", "model_evaluation"], [11, 0, 0, "-", "nearest_neighbor"], [11, 0, 0, "-", "refinement"], [11, 0, 0, "-", "stills_indexer"], [11, 0, 0, "-", "symmetry"]], "dials.algorithms.indexing.assign_indices": [[11, 1, 1, "", "AssignIndicesGlobal"], [11, 1, 1, "", "AssignIndicesLocal"], [11, 1, 1, "", "AssignIndicesStrategy"]], "dials.algorithms.indexing.assign_indices.AssignIndicesGlobal": [[11, 2, 1, "", "__init__"]], "dials.algorithms.indexing.assign_indices.AssignIndicesLocal": [[11, 2, 1, "", "__init__"]], "dials.algorithms.indexing.assign_indices.AssignIndicesStrategy": [[11, 2, 1, "", "__init__"]], "dials.algorithms.indexing.basis_vector_search": [[11, 1, 1, "", "FFT1D"], [11, 1, 1, "", "FFT3D"], [11, 1, 1, "", "RealSpaceGridSearch"], [11, 1, 1, "", "Strategy"], [11, 0, 0, "-", "combinations"], [11, 0, 0, "-", "optimise"]], "dials.algorithms.indexing.basis_vector_search.FFT1D": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_basis_vectors"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.basis_vector_search.FFT3D": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_basis_vectors"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "compute_functional"], [11, 2, 1, "", "find_basis_vectors"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"], [11, 2, 1, "", "score_vectors"], [11, 6, 1, "", "search_directions"], [11, 6, 1, "", "search_vectors"]], "dials.algorithms.indexing.basis_vector_search.Strategy": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_basis_vectors"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.basis_vector_search.combinations": [[11, 3, 1, "", "candidate_orientation_matrices"], [11, 3, 1, "", "filter_known_symmetry"], [11, 3, 1, "", "filter_similar_orientations"]], "dials.algorithms.indexing.basis_vector_search.optimise": [[11, 1, 1, "", "BasisVectorMinimiser"], [11, 1, 1, "", "BasisVectorTarget"], [11, 3, 1, "", "optimise_basis_vectors"]], "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorMinimiser": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "compute_functional_and_gradients"]], "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorTarget": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "compute_functional"], [11, 2, 1, "", "compute_functional_and_gradients"]], "dials.algorithms.indexing.compare_orientation_matrices": [[11, 3, 1, "", "difference_rotation_matrix_axis_angle"], [11, 3, 1, "", "rotation_matrix_differences"]], "dials.algorithms.indexing.indexer": [[11, 1, 1, "", "Indexer"], [11, 3, 1, "", "apply_hkl_offset"]], "dials.algorithms.indexing.indexer.Indexer": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "export_as_json"], [11, 2, 1, "", "export_reflections"], [11, 2, 1, "", "find_lattices"], [11, 2, 1, "", "find_max_cell"], [11, 2, 1, "", "from_parameters"], [11, 2, 1, "", "index"], [11, 2, 1, "", "index_reflections"], [11, 2, 1, "", "refine"], [11, 2, 1, "", "setup_indexing"], [11, 2, 1, "", "show_experiments"]], "dials.algorithms.indexing.lattice_search": [[11, 1, 1, "", "LowResSpotMatch"], [11, 1, 1, "", "PinkIndexer"], [11, 1, 1, "", "Strategy"]], "dials.algorithms.indexing.lattice_search.LowResSpotMatch": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_crystal_models"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.lattice_search.PinkIndexer": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_crystal_models"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.lattice_search.Strategy": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_crystal_models"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.max_cell": [[11, 3, 1, "", "find_max_cell"]], "dials.algorithms.indexing.model_evaluation": [[11, 1, 1, "", "ModelEvaluation"], [11, 1, 1, "", "ModelRank"], [11, 1, 1, "", "ModelRankFilter"], [11, 1, 1, "", "ModelRankWeighted"], [11, 1, 1, "", "Result"], [11, 1, 1, "", "Strategy"], [11, 3, 1, "", "filter_doubled_cell"]], "dials.algorithms.indexing.model_evaluation.ModelEvaluation": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "evaluate"]], "dials.algorithms.indexing.model_evaluation.ModelRank": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "append"], [11, 2, 1, "", "best_model"], [11, 2, 1, "", "extend"]], "dials.algorithms.indexing.model_evaluation.ModelRankFilter": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "append"], [11, 2, 1, "", "best_model"], [11, 2, 1, "", "extend"], [11, 2, 1, "", "filter_by_likelihood"], [11, 2, 1, "", "filter_by_n_indexed"], [11, 2, 1, "", "filter_by_volume"], [11, 2, 1, "", "update_analysis"]], "dials.algorithms.indexing.model_evaluation.ModelRankWeighted": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "best_model"], [11, 2, 1, "", "combined_scores"], [11, 2, 1, "", "score_by_fraction_indexed"], [11, 2, 1, "", "score_by_rmsd_xy"], [11, 2, 1, "", "score_by_volume"]], "dials.algorithms.indexing.model_evaluation.Result": [[11, 5, 1, "", "crystal"], [11, 5, 1, "", "fraction_indexed"], [11, 5, 1, "", "hkl_offset"], [11, 5, 1, "", "model_likelihood"], [11, 5, 1, "", "n_indexed"], [11, 5, 1, "", "rmsds"]], "dials.algorithms.indexing.model_evaluation.Strategy": [[11, 2, 1, "", "evaluate"]], "dials.algorithms.indexing.nearest_neighbor": [[11, 1, 1, "", "NeighborAnalysis"]], "dials.algorithms.indexing.nearest_neighbor.NeighborAnalysis": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "plot_histogram"]], "dials.algorithms.indexing.refinement": [[11, 3, 1, "", "refine"]], "dials.algorithms.indexing.stills_indexer": [[11, 1, 1, "", "StillsIndexer"], [11, 1, 1, "", "StillsIndexerBasisVectorSearch"], [11, 1, 1, "", "StillsIndexerKnownOrientation"], [11, 1, 1, "", "StillsIndexerLatticeSearch"], [11, 3, 1, "", "calc_2D_rmsd_and_displacements"], [11, 3, 1, "", "e_refine"], [11, 3, 1, "", "plot_displacements"]], "dials.algorithms.indexing.stills_indexer.StillsIndexer": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "choose_best_orientation_matrix"], [11, 2, 1, "", "experiment_list_for_crystal"], [11, 2, 1, "", "identify_outliers"], [11, 2, 1, "", "index"], [11, 2, 1, "", "refine"], [11, 2, 1, "", "warn_if_setting_unused_refinement_protocol_params"]], "dials.algorithms.indexing.symmetry": [[11, 1, 1, "", "SymmetryHandler"], [11, 3, 1, "", "calc_acentric_subgroups"], [11, 3, 1, "", "find_matching_symmetry"], [11, 3, 1, "", "groups_cache"], [11, 3, 1, "", "metric_supergroup"]], "dials.algorithms.indexing.symmetry.SymmetryHandler": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "apply_symmetry"]], "dials.algorithms.integration": [[12, 0, 0, "-", "integrator"]], "dials.algorithms.integration.integrator": [[12, 1, 1, "", "Executor"], [12, 1, 1, "", "Integrator"], [12, 1, 1, "", "Integrator2D"], [12, 1, 1, "", "Integrator3D"], [12, 1, 1, "", "Integrator3DThreaded"], [12, 1, 1, "", "IntegratorExecutor"], [12, 1, 1, "", "IntegratorFlat3D"], [12, 1, 1, "", "IntegratorSingle2D"], [12, 1, 1, "", "IntegratorStills"], [12, 1, 1, "", "JobList"], [12, 1, 1, "", "Parameters"], [12, 1, 1, "", "Processor2D"], [12, 1, 1, "", "Processor3D"], [12, 1, 1, "", "ProcessorFlat3D"], [12, 1, 1, "", "ProcessorSingle2D"], [12, 1, 1, "", "ProcessorStills"], [12, 1, 1, "", "ProfileModellerExecutor"], [12, 1, 1, "", "ProfileValidatorExecutor"], [12, 1, 1, "", "ReflectionManager"], [12, 3, 1, "", "frame_hist"], [12, 3, 1, "", "generate_phil_scope"], [12, 3, 1, "", "hist"], [12, 3, 1, "", "nframes_hist"]], "dials.algorithms.integration.integrator.Executor": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "process"]], "dials.algorithms.integration.integrator.Integrator": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "fit_profiles"], [12, 2, 1, "", "integrate"], [12, 2, 1, "", "report"], [12, 2, 1, "", "summary"]], "dials.algorithms.integration.integrator.Integrator2D": [[12, 5, 1, "", "ProcessorClass"], [12, 2, 1, "", "finalize_reflections"], [12, 2, 1, "", "initialize_reflections"]], "dials.algorithms.integration.integrator.Integrator3D": [[12, 5, 1, "", "ProcessorClass"], [12, 2, 1, "", "finalize_reflections"], [12, 2, 1, "", "initialize_reflections"]], "dials.algorithms.integration.integrator.Integrator3DThreaded": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "finalise"], [12, 2, 1, "", "initialise"], [12, 2, 1, "", "integrate"], [12, 2, 1, "", "report"], [12, 2, 1, "", "summary"]], "dials.algorithms.integration.integrator.IntegratorExecutor": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "data"], [12, 2, 1, "", "finalize"], [12, 2, 1, "", "initialize"], [12, 2, 1, "", "process"]], "dials.algorithms.integration.integrator.IntegratorFlat3D": [[12, 5, 1, "", "ProcessorClass"], [12, 2, 1, "", "finalize_reflections"], [12, 2, 1, "", "initialize_reflections"]], "dials.algorithms.integration.integrator.IntegratorSingle2D": [[12, 5, 1, "", "ProcessorClass"], [12, 2, 1, "", "finalize_reflections"], [12, 2, 1, "", "initialize_reflections"]], "dials.algorithms.integration.integrator.IntegratorStills": [[12, 5, 1, "", "ProcessorClass"], [12, 2, 1, "", "finalize_reflections"], [12, 2, 1, "", "initialize_reflections"]], "dials.algorithms.integration.integrator.JobList": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "add"], [12, 2, 1, "", "shoebox_memory"], [12, 2, 1, "", "split"]], "dials.algorithms.integration.integrator.Parameters": [[12, 1, 1, "", "Filter"], [12, 1, 1, "", "Profile"], [12, 2, 1, "", "__init__"], [12, 2, 1, "", "from_phil"]], "dials.algorithms.integration.integrator.Parameters.Filter": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.Parameters.Profile": [[12, 1, 1, "", "Validation"], [12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.Parameters.Profile.Validation": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.Processor2D": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.Processor3D": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.ProcessorFlat3D": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.ProcessorSingle2D": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.ProcessorStills": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.ProfileModellerExecutor": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "data"], [12, 2, 1, "", "finalize"], [12, 2, 1, "", "initialize"], [12, 2, 1, "", "process"]], "dials.algorithms.integration.integrator.ProfileValidatorExecutor": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "data"], [12, 2, 1, "", "finalize"], [12, 2, 1, "", "initialize"], [12, 2, 1, "", "process"]], "dials.algorithms.integration.integrator.ReflectionManager": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "accumulate"], [12, 2, 1, "", "data"], [12, 2, 1, "", "finished"], [12, 2, 1, "", "job"], [12, 2, 1, "", "num_reflections"], [12, 2, 1, "", "split"]], "dials.algorithms.refinement": [[14, 0, 0, "-", "engine"], [14, 0, 0, "-", "refiner"], [14, 0, 0, "-", "reflection_manager"], [14, 0, 0, "-", "target"], [14, 0, 0, "-", "target_stills"], [14, 0, 0, "-", "weighting_strategies"]], "dials.algorithms.refinement.engine": [[14, 1, 1, "", "AdaptLbfgs"], [14, 1, 1, "", "AdaptLstbx"], [14, 1, 1, "", "DisableMPmixin"], [14, 1, 1, "", "GaussNewtonIterations"], [14, 1, 1, "", "Journal"], [14, 1, 1, "", "LBFGScurvs"], [14, 1, 1, "", "LevenbergMarquardtIterations"], [14, 1, 1, "", "Refinery"], [14, 1, 1, "", "SimpleLBFGS"]], "dials.algorithms.refinement.engine.AdaptLbfgs": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "callback_after_step"], [14, 2, 1, "", "compute_functional_and_gradients"], [14, 2, 1, "", "compute_functional_gradients_and_curvatures"], [14, 2, 1, "", "run_lbfgs"]], "dials.algorithms.refinement.engine.AdaptLstbx": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "build_up"], [14, 2, 1, "", "calculate_esds"], [14, 2, 1, "", "parameter_vector_norm"], [14, 2, 1, "", "restart"], [14, 2, 1, "", "set_cholesky_factor"], [14, 2, 1, "", "step_backward"], [14, 2, 1, "", "step_forward"]], "dials.algorithms.refinement.engine.DisableMPmixin": [[14, 2, 1, "", "set_nproc"]], "dials.algorithms.refinement.engine.GaussNewtonIterations": [[14, 2, 1, "", "__init__"], [14, 5, 1, "", "convergence_as_shift_over_esd"], [14, 5, 1, "", "damping_value"], [14, 5, 1, "", "gradient_threshold"], [14, 5, 1, "", "max_shift_over_esd"], [14, 2, 1, "", "run"], [14, 5, 1, "", "step_threshold"]], "dials.algorithms.refinement.engine.Journal": [[14, 2, 1, "", "add_column"], [14, 2, 1, "", "add_row"], [14, 2, 1, "", "del_last_row"], [14, 2, 1, "", "from_json_file"], [14, 2, 1, "", "get_nrows"], [14, 5, 1, "", "reason_for_termination"], [14, 2, 1, "", "set_last_cell"], [14, 2, 1, "", "to_json_file"]], "dials.algorithms.refinement.engine.LBFGScurvs": [[14, 2, 1, "", "compute_functional_gradients_diag"], [14, 2, 1, "", "run"]], "dials.algorithms.refinement.engine.LevenbergMarquardtIterations": [[14, 2, 1, "", "add_constant_to_diagonal"], [14, 6, 1, "", "mu"], [14, 2, 1, "", "report_progress"], [14, 2, 1, "", "run"], [14, 2, 1, "", "setup_mu"], [14, 5, 1, "", "tau"]], "dials.algorithms.refinement.engine.Refinery": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "get_correlation_matrix_for_step"], [14, 2, 1, "", "get_num_steps"], [14, 2, 1, "", "jacobian_condition_number"], [14, 2, 1, "", "prepare_for_step"], [14, 2, 1, "", "run"], [14, 2, 1, "", "set_nproc"], [14, 2, 1, "", "split_jacobian_into_blocks"], [14, 2, 1, "", "test_for_termination"], [14, 2, 1, "", "test_objective_increasing_but_not_nref"], [14, 2, 1, "", "test_rmsd_convergence"], [14, 2, 1, "", "update_journal"]], "dials.algorithms.refinement.engine.SimpleLBFGS": [[14, 2, 1, "", "run"]], "dials.algorithms.refinement.refiner": [[14, 1, 1, "", "Refiner"], [14, 1, 1, "", "RefinerFactory"], [14, 1, 1, "", "ScanVaryingRefiner"]], "dials.algorithms.refinement.refiner.Refiner": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "calc_exp_rmsd_table"], [14, 2, 1, "", "get_experiments"], [14, 2, 1, "", "get_free_reflections"], [14, 2, 1, "", "get_matches"], [14, 2, 1, "", "get_param_reporter"], [14, 2, 1, "", "get_parameter_correlation_matrix"], [14, 6, 1, "", "history"], [14, 2, 1, "", "predict_for_indexed"], [14, 2, 1, "", "predict_for_reflection_table"], [14, 2, 1, "", "print_exp_rmsd_table"], [14, 2, 1, "", "print_out_of_sample_rmsd_table"], [14, 2, 1, "", "print_panel_rmsd_table"], [14, 2, 1, "", "print_step_table"], [14, 2, 1, "", "rmsds"], [14, 2, 1, "", "rmsds_for_reflection_table"], [14, 2, 1, "", "run"], [14, 2, 1, "", "selection_used_for_refinement"]], "dials.algorithms.refinement.refiner.RefinerFactory": [[14, 2, 1, "", "config_refinery"], [14, 2, 1, "", "config_restraints"], [14, 2, 1, "", "config_sparse"], [14, 2, 1, "", "config_target"], [14, 2, 1, "", "from_parameters_data_experiments"], [14, 2, 1, "", "reflections_after_outlier_rejection"]], "dials.algorithms.refinement.reflection_manager": [[14, 1, 1, "", "BlockCalculator"], [14, 1, 1, "", "ReflectionManager"], [14, 1, 1, "", "ReflectionManagerFactory"], [14, 1, 1, "", "StillsReflectionManager"]], "dials.algorithms.refinement.reflection_manager.BlockCalculator": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "per_image"], [14, 2, 1, "", "per_width"]], "dials.algorithms.refinement.reflection_manager.ReflectionManager": [[14, 2, 1, "", "__init__"], [14, 5, 1, "", "experiment_type"], [14, 2, 1, "", "filter_obs"], [14, 2, 1, "", "finalise"], [14, 2, 1, "", "get_accepted_refs_size"], [14, 2, 1, "", "get_centroid_analyser"], [14, 2, 1, "", "get_free_reflections"], [14, 2, 1, "", "get_indexed"], [14, 2, 1, "", "get_matches"], [14, 2, 1, "", "get_obs"], [14, 2, 1, "", "get_sample_size"], [14, 2, 1, "", "print_stats_on_matches"], [14, 2, 1, "", "reset_accepted_reflections"]], "dials.algorithms.refinement.reflection_manager.ReflectionManagerFactory": [[14, 2, 1, "", "from_parameters_reflections_experiments"]], "dials.algorithms.refinement.reflection_manager.StillsReflectionManager": [[14, 5, 1, "", "experiment_type"], [14, 2, 1, "", "print_stats_on_matches"]], "dials.algorithms.refinement.target": [[14, 1, 1, "", "LeastSquaresPositionalResidualWithRmsdCutoff"], [14, 1, 1, "", "LeastSquaresPositionalResidualWithRmsdCutoffSparse"], [14, 1, 1, "", "SparseGradientsMixin"], [14, 1, 1, "", "Target"], [14, 1, 1, "", "TargetFactory"]], "dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoff": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "achieved"]], "dials.algorithms.refinement.target.Target": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "achieved"], [14, 2, 1, "", "calculate_gradients"], [14, 2, 1, "", "compute_functional_gradients_and_curvatures"], [14, 2, 1, "", "compute_residuals"], [14, 2, 1, "", "compute_residuals_and_gradients"], [14, 2, 1, "", "compute_restraints_functional_gradients_and_curvatures"], [14, 2, 1, "", "compute_restraints_residuals_and_gradients"], [14, 6, 1, "", "dim"], [14, 2, 1, "", "get_num_matches"], [14, 2, 1, "", "get_num_matches_for_experiment"], [14, 2, 1, "", "get_num_matches_for_panel"], [14, 2, 1, "", "predict"], [14, 2, 1, "", "predict_for_free_reflections"], [14, 2, 1, "", "predict_for_reflection_table"], [14, 5, 1, "", "rmsd_names"], [14, 5, 1, "", "rmsd_units"], [14, 2, 1, "", "rmsds"], [14, 2, 1, "", "rmsds_for_experiment"], [14, 2, 1, "", "rmsds_for_panel"], [14, 2, 1, "", "rmsds_for_reflection_table"], [14, 2, 1, "", "split_matches_into_blocks"], [14, 2, 1, "", "update_matches"]], "dials.algorithms.refinement.target.TargetFactory": [[14, 2, 1, "", "from_parameters_and_experiments"]], "dials.algorithms.refinement.target_stills": [[14, 1, 1, "", "LeastSquaresStillsResidualWithRmsdCutoff"], [14, 1, 1, "", "LeastSquaresStillsResidualWithRmsdCutoffSparse"]], "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "achieved"], [14, 2, 1, "", "predict_for_reflection_table"], [14, 5, 1, "", "rmsd_names"], [14, 5, 1, "", "rmsd_units"]], "dials.algorithms.refinement.weighting_strategies": [[14, 1, 1, "", "ConstantWeightingStrategy"], [14, 1, 1, "", "ExternalDelPsiWeightingStrategy"], [14, 1, 1, "", "StatisticalWeightingStrategy"], [14, 1, 1, "", "StillsWeightingStrategy"]], "dials.algorithms.refinement.weighting_strategies.ConstantWeightingStrategy": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "calculate_weights"]], "dials.algorithms.refinement.weighting_strategies.ExternalDelPsiWeightingStrategy": [[14, 2, 1, "", "calculate_weights"]], "dials.algorithms.refinement.weighting_strategies.StatisticalWeightingStrategy": [[14, 2, 1, "", "calculate_weights"]], "dials.algorithms.refinement.weighting_strategies.StillsWeightingStrategy": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "calculate_weights"]], "dials.algorithms.scaling": [[15, 0, 0, "-", "outlier_rejection"]], "dials.algorithms.scaling.model": [[15, 0, 0, "-", "model"]], "dials.algorithms.scaling.model.model": [[15, 1, 1, "", "ArrayScalingModel"], [15, 1, 1, "", "DoseDecay"], [15, 1, 1, "", "KBScalingModel"], [15, 1, 1, "", "PhysicalScalingModel"], [15, 1, 1, "", "ScalingModelBase"], [15, 3, 1, "", "calc_n_param_from_bins"], [15, 3, 1, "", "calculate_new_offset"], [15, 3, 1, "", "determine_auto_absorption_params"], [15, 3, 1, "", "initialise_smooth_input"], [15, 3, 1, "", "make_combined_plots"], [15, 3, 1, "", "plot_scaling_models"]], "dials.algorithms.scaling.model.model.ArrayScalingModel": [[15, 2, 1, "", "__init__"], [15, 2, 1, "", "configure_components"], [15, 6, 1, "", "consecutive_refinement_order"], [15, 2, 1, "", "from_data"], [15, 2, 1, "", "from_dict"], [15, 5, 1, "", "id_"], [15, 2, 1, "", "limit_image_range"], [15, 5, 1, "", "phil_scope"], [15, 2, 1, "", "plot_model_components"], [15, 2, 1, "", "update"]], "dials.algorithms.scaling.model.model.DoseDecay": [[15, 2, 1, "", "__init__"], [15, 2, 1, "", "configure_components"], [15, 6, 1, "", "consecutive_refinement_order"], [15, 2, 1, "", "fix_initial_parameter"], [15, 2, 1, "", "from_data"], [15, 2, 1, "", "from_dict"], [15, 2, 1, "", "get_shared_components"], [15, 5, 1, "", "id_"], [15, 2, 1, "", "limit_image_range"], [15, 5, 1, "", "phil_scope"], [15, 2, 1, "", "plot_model_components"], [15, 2, 1, "", "update"]], "dials.algorithms.scaling.model.model.KBScalingModel": [[15, 2, 1, "", "__init__"], [15, 2, 1, "", "configure_components"], [15, 6, 1, "", "consecutive_refinement_order"], [15, 2, 1, "", "from_data"], [15, 2, 1, "", "from_dict"], [15, 5, 1, "", "id_"], [15, 5, 1, "", "phil_scope"], [15, 2, 1, "", "update"]], "dials.algorithms.scaling.model.model.PhysicalScalingModel": [[15, 2, 1, "", "__init__"], [15, 2, 1, "", "configure_components"], [15, 6, 1, "", "consecutive_refinement_order"], [15, 2, 1, "", "fix_initial_parameter"], [15, 2, 1, "", "from_data"], [15, 2, 1, "", "from_dict"], [15, 2, 1, "", "get_shared_components"], [15, 5, 1, "", "id_"], [15, 2, 1, "", "limit_image_range"], [15, 5, 1, "", "phil_scope"], [15, 2, 1, "", "plot_model_components"], [15, 2, 1, "", "update"]], "dials.algorithms.scaling.model.model.ScalingModelBase": [[15, 2, 1, "", "__init__"], [15, 6, 1, "", "components"], [15, 6, 1, "", "configdict"], [15, 2, 1, "", "configure_components"], [15, 2, 1, "", "consecutive_refinement_order"], [15, 6, 1, "", "error_model"], [15, 2, 1, "", "fix_initial_parameter"], [15, 6, 1, "", "fixed_components"], [15, 2, 1, "", "from_data"], [15, 2, 1, "", "from_dict"], [15, 2, 1, "", "get_shared_components"], [15, 5, 1, "", "id_"], [15, 6, 1, "", "is_scaled"], [15, 2, 1, "", "limit_image_range"], [15, 2, 1, "", "load_error_model"], [15, 6, 1, "", "n_params"], [15, 2, 1, "", "plot_model_components"], [15, 2, 1, "", "record_intensity_combination_Imid"], [15, 2, 1, "", "set_error_model"], [15, 2, 1, "", "set_scaling_model_as_scaled"], [15, 2, 1, "", "set_scaling_model_as_unscaled"], [15, 2, 1, "", "set_valid_image_range"], [15, 2, 1, "", "to_dict"], [15, 2, 1, "", "update"]], "dials.algorithms.scaling.outlier_rejection": [[15, 1, 1, "", "NormDevOutlierRejection"], [15, 1, 1, "", "OutlierRejectionBase"], [15, 1, 1, "", "SimpleNormDevOutlierRejection"], [15, 1, 1, "", "TargetedOutlierRejection"], [15, 3, 1, "", "determine_Esq_outlier_index_arrays"], [15, 3, 1, "", "determine_outlier_index_arrays"], [15, 3, 1, "", "reject_outliers"]], "dials.algorithms.scaling.outlier_rejection.NormDevOutlierRejection": [[15, 2, 1, "", "__init__"]], "dials.algorithms.scaling.outlier_rejection.OutlierRejectionBase": [[15, 2, 1, "", "__init__"], [15, 5, 1, "", "final_outlier_arrays"], [15, 2, 1, "", "run"]], "dials.algorithms.scaling.outlier_rejection.SimpleNormDevOutlierRejection": [[15, 2, 1, "", "__init__"]], "dials.algorithms.scaling.outlier_rejection.TargetedOutlierRejection": [[15, 2, 1, "", "__init__"]], "dials.algorithms.spot_finding": [[16, 0, 0, "-", "factory"], [16, 0, 0, "-", "finder"]], "dials.algorithms.spot_finding.factory": [[16, 1, 1, "", "BackgroundGradientFilter"], [16, 1, 1, "", "FilterRunner"], [16, 1, 1, "", "PeakCentroidDistanceFilter"], [16, 1, 1, "", "SpotDensityFilter"], [16, 1, 1, "", "SpotFinderFactory"], [16, 3, 1, "", "generate_phil_scope"]], "dials.algorithms.spot_finding.factory.BackgroundGradientFilter": [[16, 2, 1, "", "__init__"], [16, 2, 1, "", "run"]], "dials.algorithms.spot_finding.factory.FilterRunner": [[16, 2, 1, "", "__init__"], [16, 2, 1, "", "check_flags"]], "dials.algorithms.spot_finding.factory.PeakCentroidDistanceFilter": [[16, 2, 1, "", "__init__"], [16, 2, 1, "", "run"]], "dials.algorithms.spot_finding.factory.SpotDensityFilter": [[16, 2, 1, "", "__init__"], [16, 2, 1, "", "run"]], "dials.algorithms.spot_finding.factory.SpotFinderFactory": [[16, 2, 1, "", "configure_filter"], [16, 2, 1, "", "configure_threshold"], [16, 2, 1, "", "from_parameters"], [16, 2, 1, "", "load_image"]], "dials.algorithms.spot_finding.finder": [[16, 1, 1, "", "ExtractPixelsFromImage"], [16, 1, 1, "", "ExtractPixelsFromImage2DNoShoeboxes"], [16, 1, 1, "", "ExtractSpots"], [16, 1, 1, "", "ExtractSpotsParallelTask"], [16, 1, 1, "", "SpotFinder"], [16, 1, 1, "", "TOFSpotFinder"], [16, 3, 1, "", "pixel_list_to_reflection_table"], [16, 3, 1, "", "pixel_list_to_shoeboxes"], [16, 3, 1, "", "shoeboxes_to_reflection_table"]], "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage": [[16, 2, 1, "", "__init__"]], "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage2DNoShoeboxes": [[16, 2, 1, "", "__init__"]], "dials.algorithms.spot_finding.finder.ExtractSpots": [[16, 2, 1, "", "__init__"]], "dials.algorithms.spot_finding.finder.ExtractSpotsParallelTask": [[16, 2, 1, "", "__init__"]], "dials.algorithms.spot_finding.finder.SpotFinder": [[16, 2, 1, "", "__init__"], [16, 2, 1, "", "find_spots"]], "dials.algorithms.spot_finding.finder.TOFSpotFinder": [[16, 2, 1, "", "__init__"]], "dials.algorithms.spot_prediction": [[17, 0, 0, "-", "reflection_predictor"]], "dials.algorithms.spot_prediction.reflection_predictor": [[17, 1, 1, "", "ReflectionPredictor"]], "dials.algorithms.spot_prediction.reflection_predictor.ReflectionPredictor": [[17, 2, 1, "", "__init__"], [17, 2, 1, "", "predictor"]], "dials.algorithms.symmetry": [[18, 0, 0, "-", "cosym"], [18, 0, 0, "-", "laue_group"], [18, 3, 1, "", "median_unit_cell"], [18, 0, 0, "-", "reindex_to_reference"], [18, 3, 1, "", "resolution_filter_from_array"], [18, 3, 1, "", "resolution_filter_from_reflections_experiments"], [18, 1, 1, "", "symmetry_base"]], "dials.algorithms.symmetry.cosym": [[18, 1, 1, "", "CosymAnalysis"], [18, 1, 1, "", "ScoreSubGroup"], [18, 1, 1, "", "ScoreSymmetryElement"], [18, 1, 1, "", "SymmetryAnalysis"], [18, 3, 1, "", "change_of_basis_op_to_best_cell"], [18, 0, 0, "-", "engine"], [18, 3, 1, "", "extract_reference_intensities"], [18, 0, 0, "-", "target"]], "dials.algorithms.symmetry.cosym.CosymAnalysis": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"], [18, 2, 1, "", "as_json"], [18, 2, 1, "", "run"]], "dials.algorithms.symmetry.cosym.ScoreSubGroup": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"], [18, 6, 1, "", "stars"]], "dials.algorithms.symmetry.cosym.ScoreSymmetryElement": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"], [18, 6, 1, "", "stars"]], "dials.algorithms.symmetry.cosym.SymmetryAnalysis": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"], [18, 2, 1, "", "subgroups_table"], [18, 2, 1, "", "summary_table"], [18, 2, 1, "", "sym_ops_table"]], "dials.algorithms.symmetry.cosym.engine": [[18, 1, 1, "", "lbfgs_with_curvs"], [18, 3, 1, "", "minimize_scipy"], [18, 3, 1, "", "minimize_scitbx_lbfgs"]], "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "callback_after_step"], [18, 2, 1, "", "compute_functional_and_gradients"], [18, 2, 1, "", "compute_functional_gradients_and_curvatures"], [18, 2, 1, "", "compute_functional_gradients_diag"]], "dials.algorithms.symmetry.cosym.target": [[18, 1, 1, "", "Target"]], "dials.algorithms.symmetry.cosym.target.Target": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "compute_functional"], [18, 2, 1, "", "compute_gradients"], [18, 2, 1, "", "compute_gradients_fd"], [18, 2, 1, "", "curvatures"], [18, 2, 1, "", "curvatures_fd"], [18, 5, 1, "", "dim"], [18, 2, 1, "", "set_dimensions"]], "dials.algorithms.symmetry.laue_group": [[18, 1, 1, "", "CorrelationCoefficientAccumulator"], [18, 1, 1, "", "LaueGroupAnalysis"], [18, 1, 1, "", "ScoreCorrelationCoefficient"], [18, 1, 1, "", "ScoreSubGroup"], [18, 1, 1, "", "ScoreSymmetryElement"], [18, 3, 1, "", "trunccauchy_pdf"]], "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "accumulate"], [18, 2, 1, "", "coefficient"], [18, 2, 1, "", "denominator"], [18, 2, 1, "", "n"], [18, 2, 1, "", "numerator"]], "dials.algorithms.symmetry.laue_group.LaueGroupAnalysis": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"], [18, 2, 1, "", "as_json"]], "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient": [[18, 2, 1, "", "__init__"], [18, 6, 1, "", "p_cc_given_not_s"], [18, 6, 1, "", "p_cc_given_s"], [18, 6, 1, "", "p_s_given_cc"]], "dials.algorithms.symmetry.laue_group.ScoreSubGroup": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"]], "dials.algorithms.symmetry.laue_group.ScoreSymmetryElement": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"]], "dials.algorithms.symmetry.reindex_to_reference": [[18, 3, 1, "", "determine_reindex_operator_against_reference"]], "dials.algorithms.symmetry.symmetry_base": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "kernel_normalisation"], [18, 2, 1, "", "ml_aniso_normalisation"], [18, 2, 1, "", "ml_iso_normalisation"]], "dials.array_family": [[20, 0, 0, "-", "flex"]], "dials.extensions": [[31, 0, 0, "-", "dispersion_spotfinder_threshold_ext"], [31, 0, 0, "-", "gaussian_rs_profile_model_ext"], [31, 0, 0, "-", "null_background_ext"], [31, 0, 0, "-", "simple_background_ext"], [31, 0, 0, "-", "simple_centroid_ext"]], "dials.extensions.dispersion_spotfinder_threshold_ext": [[31, 1, 1, "", "DispersionSpotFinderThresholdExt"], [31, 3, 1, "", "estimate_global_threshold"]], "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt": [[31, 2, 1, "", "__init__"], [31, 2, 1, "", "compute_threshold"], [31, 5, 1, "", "name"], [31, 2, 1, "", "phil"]], "dials.extensions.gaussian_rs_profile_model_ext": [[31, 1, 1, "", "GaussianRSProfileModelExt"]], "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt": [[31, 2, 1, "", "algorithm"], [31, 5, 1, "", "default"], [31, 2, 1, "", "from_dict"], [31, 5, 1, "", "name"], [31, 2, 1, "", "phil"]], "dials.extensions.null_background_ext": [[31, 1, 1, "", "NullBackgroundExt"]], "dials.extensions.null_background_ext.NullBackgroundExt": [[31, 2, 1, "", "__init__"], [31, 2, 1, "", "compute_background"], [31, 5, 1, "", "name"]], "dials.extensions.simple_background_ext": [[31, 1, 1, "", "SimpleBackgroundExt"]], "dials.extensions.simple_background_ext.SimpleBackgroundExt": [[31, 2, 1, "", "__init__"], [31, 2, 1, "", "compute_background"], [31, 5, 1, "", "name"], [31, 2, 1, "", "phil"]], "dials.extensions.simple_centroid_ext": [[31, 1, 1, "", "SimpleCentroidExt"]], "dials.extensions.simple_centroid_ext.SimpleCentroidExt": [[31, 2, 1, "", "__init__"], [31, 2, 1, "", "compute_centroid"], [31, 5, 1, "", "default"], [31, 5, 1, "", "name"]], "dials.util": [[33, 0, 0, "-", "command_line"], [33, 0, 0, "-", "export_mtz"], [33, 0, 0, "-", "export_text"], [33, 0, 0, "-", "image"], [33, 0, 0, "-", "installer"], [33, 0, 0, "-", "ioutil"], [33, 0, 0, "-", "nexus"], [33, 0, 0, "-", "options"]], "dials.util.command_line": [[33, 1, 1, "", "Command"], [33, 1, 1, "", "ProgressBar"], [33, 1, 1, "", "ProgressBarTimer"], [33, 3, 1, "", "coloured"], [33, 3, 1, "", "heading"]], "dials.util.command_line.Command": [[33, 2, 1, "", "end"], [33, 5, 1, "", "indent"], [33, 5, 1, "", "max_length"], [33, 5, 1, "", "print_time"], [33, 2, 1, "", "start"]], "dials.util.command_line.ProgressBar": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "finished"], [33, 2, 1, "", "update"]], "dials.util.command_line.ProgressBarTimer": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "get_elapsed_time"], [33, 2, 1, "", "update"]], "dials.util.export_mtz": [[33, 1, 1, "", "MADMergedMTZWriter"], [33, 1, 1, "", "MTZWriterBase"], [33, 1, 1, "", "MergedMTZWriter"], [33, 1, 1, "", "WavelengthGroup"], [33, 3, 1, "", "add_batch_list"], [33, 3, 1, "", "convert_to_cambridge"], [33, 3, 1, "", "export_mtz"], [33, 3, 1, "", "log_summary"], [33, 3, 1, "", "match_wavelengths"], [33, 3, 1, "", "rotate_crystal"], [33, 3, 1, "", "write_columns"]], "dials.util.export_mtz.MADMergedMTZWriter": [[33, 2, 1, "", "add_dataset"]], "dials.util.export_mtz.MTZWriterBase": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "add_crystal"], [33, 2, 1, "", "add_empty_dataset"]], "dials.util.export_mtz.MergedMTZWriter": [[33, 2, 1, "", "add_dataset"]], "dials.util.export_mtz.WavelengthGroup": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "add_experiment"], [33, 2, 1, "", "calculate_weighted_mean"], [33, 5, 1, "", "exp_nos"], [33, 5, 1, "", "identifiers"], [33, 5, 1, "", "max_possible_wl"], [33, 5, 1, "", "min_wl"], [33, 5, 1, "", "wavelengths"], [33, 5, 1, "", "weighted_mean"]], "dials.util.export_text": [[33, 3, 1, "", "export_text"]], "dials.util.image": [[33, 1, 1, "", "reader"]], "dials.util.image.reader": [[33, 2, 1, "", "get_data"], [33, 2, 1, "", "read_file"]], "dials.util.installer": [[33, 1, 1, "", "installer"]], "dials.util.installer.installer": [[33, 5, 1, "", "base_package_options"], [33, 5, 1, "", "configure_modules"], [33, 5, 1, "", "dest_dir_prefix"], [33, 5, 1, "", "include_gui_packages"], [33, 5, 1, "", "installer_dir"], [33, 5, 1, "", "make_apps"], [33, 5, 1, "", "product_name"], [33, 2, 1, "", "product_specific_finalize_install"], [33, 5, 1, "", "remove_sources_default"], [33, 5, 1, "", "source_packages"]], "dials.util.ioutil": [[33, 3, 1, "", "get_inverse_ub_matrix_from_xparm"], [33, 3, 1, "", "get_space_group_type_from_xparm"]], "dials.util.nexus": [[33, 3, 1, "", "dump"], [33, 3, 1, "", "get_entry"], [33, 3, 1, "", "load"]], "dials.util.options": [[33, 1, 1, "", "ArgumentHandlingErrorInfo"], [33, 1, 1, "", "ArgumentParser"], [33, 1, 1, "", "ArgumentParserBase"], [33, 1, 1, "", "Importer"], [33, 4, 1, "", "InvalidPhilError"], [33, 1, 1, "", "OptionParser"], [33, 1, 1, "", "PhilCommandParser"], [33, 3, 1, "", "flatten_experiments"], [33, 3, 1, "", "flatten_reflections"], [33, 3, 1, "", "reflections_and_experiments_from_files"]], "dials.util.options.ArgumentHandlingErrorInfo": [[33, 5, 1, "", "exception"], [33, 5, 1, "", "message"], [33, 5, 1, "", "name"], [33, 5, 1, "", "traceback"], [33, 5, 1, "", "type"], [33, 5, 1, "", "validation"]], "dials.util.options.ArgumentParser": [[33, 2, 1, "", "__init__"], [33, 6, 1, "", "diff_phil"], [33, 2, 1, "", "format_help"], [33, 2, 1, "", "parse_args"], [33, 6, 1, "", "phil"], [33, 6, 1, "", "system_phil"]], "dials.util.options.ArgumentParserBase": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "format_epilog"], [33, 2, 1, "", "parse_known_args"]], "dials.util.options.Importer": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "try_read_experiments"], [33, 2, 1, "", "try_read_experiments_from_images"], [33, 2, 1, "", "try_read_reflections"]], "dials.util.options.OptionParser": [[33, 2, 1, "", "__init__"]], "dials.util.options.PhilCommandParser": [[33, 2, 1, "", "__init__"], [33, 6, 1, "", "diff_phil"], [33, 2, 1, "", "parse_args"], [33, 6, 1, "", "phil"], [33, 6, 1, "", "system_phil"]], "dxtbx": [[26, 0, 0, "-", "imageset"]], "dxtbx.imageset": [[26, 1, 1, "", "ExternalLookup"], [26, 1, 1, "", "ExternalLookupItemBool"], [26, 1, 1, "", "ExternalLookupItemDouble"], [26, 1, 1, "", "ImageGrid"], [26, 1, 1, "", "ImageSequence"], [26, 1, 1, "", "ImageSet"], [26, 1, 1, "", "ImageSetData"], [26, 1, 1, "", "ImageSetFactory"], [26, 1, 1, "", "ImageSetLazy"], [26, 1, 1, "", "MemReader"]], "dxtbx.imageset.ExternalLookup": [[26, 2, 1, "", "__init__"], [26, 6, 1, "", "dx"], [26, 6, 1, "", "dy"], [26, 6, 1, "", "gain"], [26, 6, 1, "", "mask"], [26, 6, 1, "", "pedestal"]], "dxtbx.imageset.ExternalLookupItemBool": [[26, 2, 1, "", "__init__"], [26, 6, 1, "", "data"], [26, 6, 1, "", "filename"]], "dxtbx.imageset.ExternalLookupItemDouble": [[26, 2, 1, "", "__init__"], [26, 6, 1, "", "data"], [26, 6, 1, "", "filename"]], "dxtbx.imageset.ImageGrid": [[26, 2, 1, "", "__init__"], [26, 2, 1, "", "from_imageset"], [26, 2, 1, "", "get_grid_size"]], "dxtbx.imageset.ImageSequence": [[26, 2, 1, "", "__init__"], [26, 2, 1, "", "complete_set"], [26, 2, 1, "", "get_array_range"], [26, 2, 1, "", "get_beam"], [26, 2, 1, "", "get_detector"], [26, 2, 1, "", "get_goniometer"], [26, 2, 1, "", "get_scan"], [26, 2, 1, "", "get_template"], [26, 2, 1, "", "partial_set"], [26, 2, 1, "", "set_beam"], [26, 2, 1, "", "set_detector"], [26, 2, 1, "", "set_goniometer"], [26, 2, 1, "", "set_scan"], [26, 2, 1, "", "update_detector_px_mm_data"]], "dxtbx.imageset.ImageSet": [[26, 2, 1, "", "__init__"], [26, 2, 1, "", "as_imageset"], [26, 2, 1, "", "clear_cache"], [26, 2, 1, "", "complete_set"], [26, 2, 1, "", "data"], [26, 6, 1, "", "external_lookup"], [26, 2, 1, "", "get_beam"], [26, 2, 1, "", "get_corrected_data"], [26, 2, 1, "", "get_detector"], [26, 2, 1, "", "get_detectorbase"], [26, 2, 1, "", "get_format_class"], [26, 2, 1, "", "get_gain"], [26, 2, 1, "", "get_goniometer"], [26, 2, 1, "", "get_image_identifier"], [26, 2, 1, "", "get_mask"], [26, 2, 1, "", "get_path"], [26, 2, 1, "", "get_pedestal"], [26, 2, 1, "", "get_raw_data"], [26, 2, 1, "", "get_scan"], [26, 2, 1, "", "get_spectrum"], [26, 2, 1, "", "get_vendortype"], [26, 2, 1, "", "has_dynamic_mask"], [26, 2, 1, "", "indices"], [26, 2, 1, "", "is_marked_for_rejection"], [26, 2, 1, "", "mark_for_rejection"], [26, 2, 1, "", "masker"], [26, 2, 1, "", "params"], [26, 2, 1, "", "partial_set"], [26, 2, 1, "", "paths"], [26, 2, 1, "", "reader"], [26, 2, 1, "", "set_beam"], [26, 2, 1, "", "set_detector"], [26, 2, 1, "", "set_goniometer"], [26, 2, 1, "", "set_scan"], [26, 2, 1, "", "size"], [26, 2, 1, "", "update_detector_px_mm_data"]], "dxtbx.imageset.ImageSetData": [[26, 2, 1, "", "__init__"], [26, 6, 1, "", "external_lookup"], [26, 2, 1, "", "get_beam"], [26, 2, 1, "", "get_data"], [26, 2, 1, "", "get_detector"], [26, 2, 1, "", "get_format_class"], [26, 2, 1, "", "get_goniometer"], [26, 2, 1, "", "get_image_identifier"], [26, 2, 1, "", "get_master_path"], [26, 2, 1, "", "get_params"], [26, 2, 1, "", "get_path"], [26, 2, 1, "", "get_scan"], [26, 2, 1, "", "get_template"], [26, 2, 1, "", "get_vendor"], [26, 2, 1, "", "has_single_file_reader"], [26, 2, 1, "", "is_marked_for_rejection"], [26, 2, 1, "", "mark_for_rejection"], [26, 2, 1, "", "masker"], [26, 2, 1, "", "partial_data"], [26, 2, 1, "", "reader"], [26, 2, 1, "", "set_beam"], [26, 2, 1, "", "set_detector"], [26, 2, 1, "", "set_format_class"], [26, 2, 1, "", "set_goniometer"], [26, 2, 1, "", "set_params"], [26, 2, 1, "", "set_scan"], [26, 2, 1, "", "set_template"], [26, 2, 1, "", "set_vendor"]], "dxtbx.imageset.ImageSetFactory": [[26, 2, 1, "", "from_template"], [26, 2, 1, "", "imageset_from_anyset"], [26, 2, 1, "", "make_imageset"], [26, 2, 1, "", "make_sequence"], [26, 2, 1, "", "new"]], "dxtbx.imageset.ImageSetLazy": [[26, 2, 1, "", "get_beam"], [26, 2, 1, "", "get_corrected_data"], [26, 2, 1, "", "get_detector"], [26, 2, 1, "", "get_gain"], [26, 2, 1, "", "get_goniometer"], [26, 2, 1, "", "get_mask"], [26, 2, 1, "", "get_scan"]], "dxtbx.imageset.MemReader": [[26, 2, 1, "", "__init__"], [26, 2, 1, "", "copy"], [26, 2, 1, "", "identifiers"], [26, 2, 1, "", "is_single_file_reader"], [26, 2, 1, "", "master_path"], [26, 2, 1, "", "paths"], [26, 2, 1, "", "read"]], "dxtbx.model": [[22, 1, 1, "", "Crystal"], [23, 1, 1, "", "Detector"], [24, 1, 1, "", "ExperimentList"], [22, 1, 1, "", "MosaicCrystalKabsch2010"], [22, 1, 1, "", "MosaicCrystalSauter2014"], [21, 0, 0, "-", "beam"], [22, 0, 0, "-", "crystal"], [23, 0, 0, "-", "detector"], [24, 0, 0, "-", "experiment_list"], [25, 0, 0, "-", "goniometer"], [28, 0, 0, "-", "profile"], [29, 0, 0, "-", "scan"]], "dxtbx.model.Crystal": [[22, 2, 1, "", "__init__"], [22, 2, 1, "", "as_str"], [22, 2, 1, "", "from_dict"], [22, 2, 1, "", "get_crystal_symmetry"], [22, 2, 1, "", "show"], [22, 2, 1, "", "to_dict"]], "dxtbx.model.Detector": [[23, 2, 1, "", "__init__"], [23, 2, 1, "", "add_group"], [23, 2, 1, "", "add_panel"], [23, 2, 1, "", "from_dict"], [23, 2, 1, "", "get_max_inscribed_resolution"], [23, 2, 1, "", "get_max_resolution"], [23, 2, 1, "", "get_names"], [23, 2, 1, "", "get_panel_intersection"], [23, 2, 1, "", "get_ray_intersection"], [23, 2, 1, "", "has_projection_2d"], [23, 2, 1, "", "hierarchy"], [23, 2, 1, "", "is_similar_to"], [23, 2, 1, "", "iter_levelorder"], [23, 2, 1, "", "iter_panels"], [23, 2, 1, "", "iter_preorder"], [23, 2, 1, "", "rotate_around_origin"], [23, 2, 1, "", "to_dict"]], "dxtbx.model.ExperimentList": [[24, 2, 1, "", "__init__"], [24, 2, 1, "", "all_laue"], [24, 2, 1, "", "all_rotations"], [24, 2, 1, "", "all_sequences"], [24, 2, 1, "", "all_stills"], [24, 2, 1, "", "all_tof"], [24, 2, 1, "", "append"], [24, 2, 1, "", "as_file"], [24, 2, 1, "", "as_json"], [24, 2, 1, "", "beams"], [24, 2, 1, "", "change_basis"], [24, 2, 1, "", "clear"], [24, 2, 1, "", "crystals"], [24, 2, 1, "", "detectors"], [24, 2, 1, "", "empty"], [24, 2, 1, "", "extend"], [24, 2, 1, "", "find"], [24, 2, 1, "", "from_file"], [24, 2, 1, "", "from_templates"], [24, 2, 1, "", "goniometers"], [24, 2, 1, "", "identifiers"], [24, 2, 1, "", "imagesets"], [24, 2, 1, "", "indices"], [24, 2, 1, "", "is_consistent"], [24, 2, 1, "", "nullify_all_single_file_reader_format_instances"], [24, 2, 1, "", "profiles"], [24, 2, 1, "", "remove_on_experiment_identifiers"], [24, 2, 1, "", "replace"], [24, 2, 1, "", "scaling_models"], [24, 2, 1, "", "scans"], [24, 2, 1, "", "select_on_experiment_identifiers"], [24, 2, 1, "", "to_dict"], [24, 2, 1, "", "where"]], "dxtbx.model.MosaicCrystalKabsch2010": [[22, 2, 1, "", "__init__"], [22, 2, 1, "", "as_str"], [22, 2, 1, "", "from_dict"], [22, 2, 1, "", "get_mosaicity"], [22, 2, 1, "", "is_similar_to"], [22, 2, 1, "", "set_mosaicity"], [22, 2, 1, "", "to_dict"]], "dxtbx.model.MosaicCrystalSauter2014": [[22, 2, 1, "", "__init__"], [22, 2, 1, "", "as_str"], [22, 2, 1, "", "from_dict"], [22, 2, 1, "", "get_A_as_sqr"], [22, 2, 1, "", "get_A_inverse_as_sqr"], [22, 2, 1, "", "get_domain_size_ang"], [22, 2, 1, "", "get_half_mosaicity_deg"], [22, 2, 1, "", "is_similar_to"], [22, 2, 1, "", "set_domain_size_ang"], [22, 2, 1, "", "set_half_mosaicity_deg"], [22, 2, 1, "", "to_dict"]], "dxtbx.model.beam": [[21, 1, 1, "", "BeamFactory"]], "dxtbx.model.beam.BeamFactory": [[21, 2, 1, "", "complex"], [21, 2, 1, "", "from_dict"], [21, 2, 1, "", "from_phil"], [21, 2, 1, "", "imgCIF"], [21, 2, 1, "", "imgCIF_H"], [21, 2, 1, "", "make_beam"], [21, 2, 1, "", "make_polarized_beam"], [21, 2, 1, "", "make_polychromatic_beam"], [21, 2, 1, "", "simple"], [21, 2, 1, "", "simple_directional"]], "dxtbx.model.crystal": [[22, 1, 1, "", "CrystalFactory"]], "dxtbx.model.crystal.CrystalFactory": [[22, 2, 1, "", "from_dict"], [22, 2, 1, "", "from_mosflm_matrix"]], "dxtbx.model.detector": [[23, 1, 1, "", "DetectorFactory"], [23, 3, 1, "", "merge_panel_scope_extracts_by_id"]], "dxtbx.model.detector.DetectorFactory": [[23, 2, 1, "", "complex"], [23, 2, 1, "", "from_dict"], [23, 2, 1, "", "from_phil"], [23, 2, 1, "", "generate_from_phil"], [23, 2, 1, "", "imgCIF"], [23, 2, 1, "", "imgCIF_H"], [23, 2, 1, "", "make_detector"], [23, 2, 1, "", "overwrite_from_phil"], [23, 2, 1, "", "sensor"], [23, 2, 1, "", "simple"], [23, 2, 1, "", "two_theta"]], "dxtbx.model.experiment_list": [[24, 1, 1, "", "BeamComparison"], [24, 1, 1, "", "DetectorComparison"], [24, 1, 1, "", "ExperimentListFactory"], [24, 1, 1, "", "GoniometerComparison"]], "dxtbx.model.experiment_list.BeamComparison": [[24, 2, 1, "", "__init__"]], "dxtbx.model.experiment_list.DetectorComparison": [[24, 2, 1, "", "__init__"]], "dxtbx.model.experiment_list.ExperimentListFactory": [[24, 2, 1, "", "from_args"], [24, 2, 1, "", "from_dict"], [24, 2, 1, "", "from_filenames"], [24, 2, 1, "", "from_imageset_and_crystal"], [24, 2, 1, "", "from_json"], [24, 2, 1, "", "from_json_file"], [24, 2, 1, "", "from_pickle_file"], [24, 2, 1, "", "from_sequence_and_crystal"], [24, 2, 1, "", "from_serialized_format"], [24, 2, 1, "", "from_stills_and_crystal"], [24, 2, 1, "", "from_templates"], [24, 2, 1, "", "from_xds"]], "dxtbx.model.experiment_list.GoniometerComparison": [[24, 2, 1, "", "__init__"]], "dxtbx.model.goniometer": [[25, 1, 1, "", "Goniometer"], [25, 1, 1, "", "GoniometerFactory"], [25, 1, 1, "", "KappaGoniometer"], [25, 1, 1, "", "MultiAxisGoniometer"]], "dxtbx.model.goniometer.Goniometer": [[25, 2, 1, "", "__init__"], [25, 2, 1, "", "from_dict"], [25, 2, 1, "", "get_fixed_rotation"], [25, 2, 1, "", "get_num_scan_points"], [25, 2, 1, "", "get_rotation_axis"], [25, 2, 1, "", "get_rotation_axis_datum"], [25, 2, 1, "", "get_setting_rotation"], [25, 2, 1, "", "get_setting_rotation_at_scan_point"], [25, 2, 1, "", "get_setting_rotation_at_scan_points"], [25, 2, 1, "", "is_similar_to"], [25, 6, 1, "", "num_scan_points"], [25, 2, 1, "", "reset_scan_points"], [25, 2, 1, "", "rotate_around_origin"], [25, 2, 1, "", "set_fixed_rotation"], [25, 2, 1, "", "set_rotation_axis"], [25, 2, 1, "", "set_rotation_axis_datum"], [25, 2, 1, "", "set_setting_rotation"], [25, 2, 1, "", "set_setting_rotation_at_scan_points"], [25, 2, 1, "", "to_dict"]], "dxtbx.model.goniometer.GoniometerFactory": [[25, 2, 1, "", "from_dict"], [25, 2, 1, "", "from_phil"], [25, 2, 1, "", "imgCIF"], [25, 2, 1, "", "imgCIF_H"], [25, 2, 1, "", "kappa"], [25, 2, 1, "", "known_axis"], [25, 2, 1, "", "make_goniometer"], [25, 2, 1, "", "make_kappa_goniometer"], [25, 2, 1, "", "make_multi_axis_goniometer"], [25, 2, 1, "", "multi_axis"], [25, 2, 1, "", "multi_axis_goniometer_from_phil"], [25, 2, 1, "", "single_axis"], [25, 2, 1, "", "single_axis_goniometer_from_phil"], [25, 2, 1, "", "single_axis_reverse"]], "dxtbx.model.goniometer.KappaGoniometer": [[25, 2, 1, "", "__init__"], [25, 2, 1, "", "get_alpha_angle"], [25, 2, 1, "", "get_direction"], [25, 2, 1, "", "get_kappa_angle"], [25, 2, 1, "", "get_kappa_axis"], [25, 2, 1, "", "get_omega_angle"], [25, 2, 1, "", "get_omega_axis"], [25, 2, 1, "", "get_phi_angle"], [25, 2, 1, "", "get_phi_axis"], [25, 2, 1, "", "get_scan_axis"]], "dxtbx.model.goniometer.MultiAxisGoniometer": [[25, 2, 1, "", "__init__"], [25, 2, 1, "", "from_dict"], [25, 2, 1, "", "get_angles"], [25, 2, 1, "", "get_axes"], [25, 2, 1, "", "get_names"], [25, 2, 1, "", "get_scan_axis"], [25, 2, 1, "", "set_angles"], [25, 2, 1, "", "set_axes"], [25, 2, 1, "", "to_dict"]], "dxtbx.model.profile": [[28, 1, 1, "", "ProfileModelFactory"]], "dxtbx.model.profile.ProfileModelFactory": [[28, 2, 1, "", "from_dict"]], "dxtbx.model.scan": [[29, 1, 1, "", "ScanFactory"]], "dxtbx.model.scan.ScanFactory": [[29, 2, 1, "", "add"], [29, 2, 1, "", "from_dict"], [29, 2, 1, "", "from_phil"], [29, 2, 1, "", "imgCIF"], [29, 2, 1, "", "imgCIF_H"], [29, 2, 1, "", "make_scan"], [29, 2, 1, "", "make_scan_from_properties"], [29, 2, 1, "", "search"], [29, 2, 1, "", "single_file"]], "dxtbx.serialize": [[30, 0, 0, "-", "imageset"], [30, 0, 0, "-", "load"], [30, 0, 0, "-", "xds"]], "dxtbx.serialize.imageset": [[30, 3, 1, "", "basic_imageset_from_dict"], [30, 3, 1, "", "basic_imageset_to_dict"], [30, 3, 1, "", "filename_or_none"], [30, 3, 1, "", "filename_to_absolute"], [30, 3, 1, "", "imagesequence_from_dict"], [30, 3, 1, "", "imagesequence_to_dict"], [30, 3, 1, "", "imageset_from_dict"], [30, 3, 1, "", "imageset_to_dict"]], "dxtbx.serialize.load": [[30, 3, 1, "", "crystal"], [30, 3, 1, "", "experiment_list"], [30, 3, 1, "", "imageset"]], "dxtbx.serialize.xds": [[30, 3, 1, "", "to_crystal"], [30, 3, 1, "", "to_imageset"], [30, 1, 1, "", "to_xds"], [30, 3, 1, "", "xds_detector_name"]], "dxtbx.serialize.xds.to_xds": [[30, 2, 1, "", "XDS_INP"], [30, 2, 1, "", "__init__"], [30, 2, 1, "", "get_beam"], [30, 2, 1, "", "get_detector"], [30, 2, 1, "", "get_goniometer"], [30, 2, 1, "", "get_scan"], [30, 2, 1, "", "get_template"], [30, 2, 1, "", "xparm_xds"]]}, "objnames": {"0": ["py", "module", "Python module"], "1": ["py", "class", "Python class"], "2": ["py", "method", "Python method"], "3": ["py", "function", "Python function"], "4": ["py", "exception", "Python exception"], "5": ["py", "attribute", "Python attribute"], "6": ["py", "property", "Python property"]}, "objtypes": {"0": "py:module", "1": "py:class", "2": "py:method", "3": "py:function", "4": "py:exception", "5": "py:attribute", "6": "py:property"}, "terms": {"": [2, 4, 6, 14, 18, 35, 43, 49, 51, 53, 54, 59, 60, 63, 70, 72, 73, 74, 76, 78, 81, 82, 83, 84, 86, 87, 88, 95], "0": [1, 2, 3, 4, 6, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 25, 26, 29, 33, 34, 35, 37, 38, 39, 40, 41, 43, 44, 45, 46, 47, 48, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 62, 63, 64, 66, 67, 68, 69, 70, 72, 73, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96], "00": [40, 42, 50, 73, 74, 76, 77, 78, 79, 81, 82, 84, 85, 86, 87, 96], "000": [40, 75, 76, 79, 81, 82, 84, 85, 86, 88], "0000": [73, 74, 78, 81, 82, 85, 86, 88], "00000": [82, 86], "00001": 74, "0001": [33, 63, 72, 82], "0001204": 81, "0001275": 86, "0001419": 81, "0001711": 86, "0001998": 82, "0002": [74, 82, 85], "000205118": 82, "0002209": 86, "000276": 81, "0002905": 82, "0003111": 86, "0003543": [], "0003546": 86, "000363": 86, "0003692": 86, "0003775": [], "000379": 86, "0003891": 86, "0004102": 86, "0004506": 86, "0004518": 81, "0004634": 86, "00047": 76, "0004804": 86, "0004832": 81, "0004946": 86, "000498": 82, "0005383": 86, "0005444": 86, "0005848": 86, "0006": 81, "00062": 76, "0006215": 86, "0006226": [], "0006477": 86, "0006649": 86, "0006705": 81, "0006723": 86, "0007": 14, "00072": 74, "0007391": 81, "0007586": 86, "0007615": [], "0007655": 81, "00078": 76, "0007897": 86, "0008": 85, "0008039": 86, "0008083": 86, "0008088": [], "0008108": 86, "0008164": 81, "000831161": 86, "00083136": [], "0008647": 81, "00087": 84, "0009": [81, 86], "0009226": 86, "0009726389448611214": 3, "001": [14, 40, 53, 59, 60, 73, 82, 84], "0010": 86, "001011": 82, "001016": 82, "00103": 86, "001032": [], "001034": 86, "00104": [73, 86], "00105738": 82, "001113": 82, "0012": [76, 86], "001238": 82, "0013": [76, 81, 82, 85], "001314": 82, "001424": 82, "001455": 82, "001485": 83, "001499": 83, "0015": 76, "001552": 82, "0016": 83, "001655": 82, "00168": 81, "00171": 82, "001733": 81, "00175": 82, "001821": 81, "00193": 86, "00196911": 82, "002": [16, 46, 47, 50, 51, 82, 84], "002058": 82, "00206": 73, "0021": [82, 84], "002108": 81, "0021159302715049923": 3, "0021250002879257116": 3, "002168": 82, "002213": 81, "002306": 82, "0025": 53, "002529": 86, "002579": 82, "0026": 82, "0027": 82, "002731": 82, "0028": 78, "002804": 82, "002887": 86, "0029": 86, "003": [73, 84], "0030": [85, 86], "00306": 82, "0032": 74, "003241": 82, "0033": 84, "00340589": 82, "00340611": 82, "0035": [81, 85, 86], "00356": 88, "0036": [40, 84, 86], "003802": 82, "0039": [40, 84, 85], "003907": 74, "004": [41, 51, 54, 58, 73, 76, 82, 84, 85], "0040": 82, "00401706": [53, 59, 60], "0041": [81, 82, 86], "00417": 73, "0042": [40, 84], "0043": [40, 84], "0044": 74, "0045": 82, "0047": [85, 86], "0048": 85, "005": [54, 73, 79, 82, 84], "0051": 74, "0052": [40, 82, 84], "0053": [74, 82, 86], "0054": [], "005551": 82, "00556521": [], "00556579": 86, "00567814": [], "00567871": 86, "005739": 81, "005742": 81, "006": [82, 84, 86], "0060": 85, "0065": [40, 81, 84], "0067": 81, "007": [73, 88], "0070": 85, "0071": 81, "0072": 74, "0075": 81, "0076": 82, "0077": 82, "0078": 82, "007852057721998333": 3, "008": [84, 88], "008012": 75, "0082": 74, "0089": 82, "009": 82, "0090": 82, "0091": [78, 82, 85], "009233084500921031": 3, "0093": 85, "0094": 85, "00945189": [], "00945197": 86, "0097": 86, "0098": 86, "009998": 81, "00h": 79, "01": [22, 35, 40, 54, 73, 74, 75, 76, 77, 79, 81, 82, 84, 85, 86, 95, 96], "010": [84, 88], "0101": 74, "0102340": 82, "01025": 81, "01035": 81, "0107": 85, "0108": 82, "0109": [81, 82], "01092": 81, "011": [73, 82, 84, 86], "01104": 81, "0111": 85, "01122": 86, "0114": 86, "0115": 85, "0117": [74, 82, 85], "0118": 85, "011931": 86, "0119311": [], "012": [79, 84, 85, 86, 88], "013": [82, 84, 85, 86, 87], "0131": 85, "0134": 86, "01357": 86, "0137": 74, "0139": 86, "014": 84, "0140": 86, "0144": 86, "0145": 86, "015": [74, 79, 84, 86, 87], "0150": 85, "0151": 86, "0152": 81, "015245": 81, "015246": 81, "015251": 81, "015256": 81, "015267": 81, "015269": 81, "015287": 81, "0153": 82, "01535": 81, "015395": 81, "0154": 82, "0155": [82, 86], "0156": [81, 82], "015875": 81, "016": [82, 84, 86], "0163": 86, "016585": 85, "016592": 85, "016653": 85, "016897": 85, "017": [73, 82, 84], "0171": 85, "0172": 85, "0173": 81, "017411": 85, "018": [76, 84], "0180": 86, "0181": [82, 85], "018138": 75, "018187": 85, "0182": [82, 85], "0185": 85, "0187": 82, "0188": [82, 86], "0189": 86, "019": [76, 82, 84, 86, 87], "0190": 86, "0192": 86, "019202": 81, "0193": 82, "0194": [74, 82], "0195": 82, "019552": 81, "019553": 81, "019579": 81, "01966": 81, "0198": 86, "019867": 81, "02": [1, 14, 40, 41, 51, 53, 54, 58, 59, 60, 74, 76, 79, 81, 82, 84, 85, 86, 95, 96], "020": [73, 76, 79, 82, 84, 86], "02000": [82, 86], "0202": 86, "0203": 86, "0209": 74, "021": [76, 78, 82, 84, 85], "02159": 81, "021919": 81, "021931": 81, "022": [81, 82, 84], "02202": 81, "02204": 81, "022041": 81, "0221": 85, "02218": 88, "0222": 88, "0224": 82, "0225": 82, "02263": 81, "0227": 86, "022913": 81, "02297": 83, "023": [73, 76, 82, 84, 88], "0231": 82, "02339": 81, "0237": 78, "024": [84, 88], "0244": 74, "0246": 86, "0247": 86, "0248": 86, "0249": 86, "025": [76, 82, 84, 86, 88], "0250": 78, "02501": 73, "0251": 74, "0252": 82, "02585": 83, "02594": 83, "026": [76, 84, 86, 87], "027": [78, 82, 84, 86], "0275": 83, "02791": 81, "027998": 81, "028": [73, 76, 78, 82, 84, 85], "0280": 88, "028146": 81, "02846": 81, "0286": [], "0289": 83, "029": [11, 53, 79, 82, 84, 88], "0293": [83, 88], "02939": 86, "02982": 86, "02988": 81, "02996": 86, "02997": 81, "02d": [76, 83], "03": [38, 40, 73, 76, 79, 81, 82, 84, 85, 86, 95, 96], "030": [82, 84, 85, 87, 88], "03001": 86, "03019": 86, "03025": 86, "03034": 86, "03065": 86, "03096": 86, "031": [78, 82, 84, 85, 86], "03118": 86, "03122": 86, "03123": 86, "03127": 86, "03149": 86, "03157": 86, "03158": 86, "032": [73, 79, 82, 84, 86, 88], "0320": 81, "03204": 86, "03208": 86, "03209": 86, "0321": 74, "0322": 86, "03243": 86, "0326": 86, "03272": 86, "03288": 86, "03293": [], "03294": 86, "03295": 86, "033": [73, 76, 78, 82, 84, 87], "03302": 86, "03338": 86, "03376": 81, "03379": 86, "03395": 86, "03396": [], "034": [73, 79, 84], "03409": 86, "03422": 86, "03425": 86, "03433": 86, "0344": 75, "0345": 86, "034575": 81, "03468": 81, "0347": 86, "03481": 81, "03482": 86, "03485": 86, "03495": 86, "03496": [], "035": [79, 84, 85, 86, 87], "03501": 86, "03515": 86, "03518": 81, "03532": 86, "0356": 81, "03563": 86, "03577": 81, "03583": 86, "03588": 81, "036": [84, 85, 86], "03613": 82, "03614": 82, "03646": 86, "03656": 81, "03677": 82, "03682": 81, "037": [82, 84, 85, 86, 87], "03702": 82, "03707": 86, "03718": 82, "0372": 86, "0373": 82, "03742": 86, "0375": 86, "03772": 82, "038": [76, 85, 96], "03842": 82, "038826": 81, "03884": 86, "039": [76, 82, 84, 85, 86], "039473": [], "039474": [], "039475": [82, 86], "039476": 86, "039479": [], "03948": 86, "039488": [], "039489": 86, "03953": 82, "039693": [], "039695": 86, "03982": 82, "03984": 82, "03988": 82, "04": [40, 44, 73, 74, 76, 78, 79, 81, 82, 84, 85, 86, 88, 95, 96], "040": [78, 84, 86, 87], "04029": 83, "040455": 81, "040469": 86, "040471": 86, "040475": 86, "040476": [], "04049": 82, "040498": 86, "040613": 86, "040659": [], "040661": 86, "040762": 81, "0409": 84, "041": [73, 76, 81, 84, 86], "04112": 81, "041158": 86, "04119": 82, "0412": 84, "04124": 82, "04128": 81, "0413": 82, "04132": 82, "04138": 81, "0414": 84, "041514": 81, "0416": 86, "0417": 84, "04171": 82, "04174": 81, "04178": 81, "0418": 84, "04183": [82, 86], "042": [76, 84, 85], "0421": 82, "04222": 81, "042236": 85, "0424": 81, "042413": 85, "042452": 85, "04251": 81, "042591": 85, "04261": 81, "042631": 85, "042632": 85, "042657": 81, "04269": 82, "0427": 85, "0429": 85, "043": [78, 79, 82, 84, 86], "043153": [], "043154": 86, "043495": 81, "0438": 84, "0439": 84, "044": [73, 84], "0441": [82, 84], "044181": 86, "0442": 84, "04424": 82, "0443": 84, "04434": 82, "04435": 82, "0444": 84, "0445": 82, "04459": 82, "04466": [81, 82], "044662": 81, "044668": 81, "04467": 82, "04468": 81, "044695": 81, "044708": 81, "044746": 81, "04477": 82, "04478": 82, "0448": 84, "044868": 81, "045": [73, 76, 84, 85], "045054": 81, "04519": 82, "045205": 81, "045228": 81, "04524": [81, 82], "04528": 82, "0453": 85, "04538": [81, 82], "0455": 86, "045568": 81, "04558": 86, "0457": 86, "045937": 81, "046": [73, 76, 84, 85, 86], "04602": 86, "04604": 82, "046104": 85, "046255": [86, 87], "046257": [], "046259": [86, 87], "046261": [], "046263": [86, 87], "046264": [], "046274": [86, 87], "046276": [], "046337": [86, 87], "046338": [], "04634": 81, "04642": 82, "0467": 84, "04673": 82, "04679": 82, "0468": 83, "04686": 82, "046957": 86, "04698": 86, "046981": 86, "046993": 86, "046997": 86, "047": [73, 74, 76, 84, 86], "047719": 81, "047721": 81, "047726": 81, "047736": 81, "047738": 81, "047759": 81, "047833": 81, "047836": [], "047837": 86, "047924": [86, 87], "047928": [86, 87], "04794": 82, "047941": [86, 87], "047964": [86, 87], "048": [76, 84], "048039": [86, 87], "0481": 75, "048167": 81, "04847": 86, "048472": 86, "048479": 86, "048491": 86, "0485": 86, "048503": 86, "048515": 86, "04852": 86, "048528": 86, "048535": 86, "048536": 86, "048537": 86, "04854": 86, "04859": 86, "048681": 86, "048684": 86, "048696": 86, "048722": 86, "048834": 86, "049": [84, 85, 86, 87], "049034": 81, "04913": 82, "049152": 86, "049153": 86, "049155": 86, "049156": 86, "049172": 86, "0492": 82, "049219": 82, "049287": 82, "049393": 82, "0494": 86, "049473": 86, "049474": 86, "049483": 86, "049494": 86, "049495": 86, "049498": 86, "049499": 86, "049507": 82, "049518": 86, "0496": 83, "049663": 82, "0497": 85, "04974": 82, "049808": 81, "05": [11, 14, 21, 40, 41, 51, 53, 54, 58, 69, 72, 74, 75, 76, 81, 82, 83, 84, 85, 86, 88, 96], "050": [73, 76, 82, 84, 86, 87], "050076": 81, "05018": 82, "050231": 82, "05039": 82, "05068": 82, "050729": 81, "05077": 82, "05087": 82, "050901": [86, 87], "050906": [86, 87], "05097": 82, "051": [73, 75, 76, 82, 84, 85], "051014": 81, "05102": 82, "051066": [86, 87], "0511": 82, "05114": 82, "051142": 81, "051408": 81, "051594": 82, "052": [73, 76, 82, 84, 85, 86], "052336": [86, 87], "052372": [86, 87], "052378": [86, 87], "052619": 81, "052654": 81, "05266": 82, "05293": 82, "053": [73, 84, 85, 87], "05329": 82, "05334": 82, "05341": 82, "053549": 82, "05362": 82, "05369": 82, "05383": 84, "05389": 84, "05395": 84, "054": [73, 76, 84, 86], "05406": 84, "05422": 84, "05445": 82, "0546": 88, "055": [74, 76, 84, 85, 86], "05535": 84, "05536": 84, "05538": 81, "055477": 82, "055785": [86, 87], "056": [76, 84, 85, 86], "0561": 88, "05629": 82, "05684": 84, "056976": 81, "057": [78, 84], "05703": 84, "05713": 82, "05721": 84, "05753": 82, "057678": 82, "057682": 82, "057685": 82, "057687": 82, "057688": 82, "057702": 82, "057786": 81, "057788": 82, "057789": 86, "057829": 81, "05791": 81, "058": [3, 73, 82, 84], "058023": 81, "058114": 81, "058126": 82, "058127": 81, "058167": 81, "058198": 81, "058208": 81, "05821": 81, "058323": 82, "05853": 84, "058974": 82, "059": [73, 82, 84, 85, 86, 87], "059567": [86, 87], "05968": 82, "0598562": 86, "05ch11231": [0, 90], "06": [18, 23, 24, 25, 40, 48, 63, 73, 74, 76, 81, 82, 83, 84, 85, 86], "060": [76, 79, 84], "06016": 86, "06024": 86, "06032": 86, "060443": 82, "060489": 81, "06057": 84, "06074": 84, "061": [76, 82, 84, 85, 86], "061756": 81, "062": [73, 79, 82, 84, 86], "06229": 81, "062547": 82, "0626": [83, 86], "06294": 86, "063": [76, 81, 82, 85, 86, 87, 88], "063075": 81, "063395": 81, "063401": 81, "063419": 81, "063456": 81, "06351": 81, "063529": 81, "063617": 81, "063629": 81, "063644": 81, "063645": 81, "063654": 81, "063682": 81, "063706": 81, "063734": 81, "06379": 81, "0638": 86, "063825": 81, "063827": 81, "0639": 86, "063949": 81, "064": [76, 84, 85], "064045": 81, "064091": 81, "06414": 81, "06416": 81, "06454": 81, "06467": 81, "06472": 84, "06499": 85, "065": [84, 86], "06501": 84, "06504": 82, "065253": 85, "065257": 85, "06528": 84, "065282": 85, "06533": 84, "065412": 85, "0656": 82, "065727": 85, "06574": 81, "066": [84, 85, 86], "066176": 85, "066238": 81, "06627": 81, "066282": 82, "06694": 86, "067": [73, 76, 84, 86, 88], "067273": 81, "0673": 83, "067369": 81, "067371": 81, "067439": 81, "067531": 81, "067587": 81, "067607": 81, "067617": 81, "06762": 81, "068": [73, 82, 84, 85, 87], "0684": 78, "068866": 81, "069": [76, 84, 85], "06931": 81, "069418": 82, "069424": 82, "069463": 82, "069491": 81, "069573": 82, "069583": 82, "069746": 82, "069797": 82, "069841": 82, "069855": 82, "06e": 84, "06m": 79, "07": [48, 74, 75, 76, 77, 81, 82, 83, 84, 86], "070": [79, 86], "071": [73, 76, 77, 82, 84, 85, 86], "07167": 81, "072": [73, 76, 84, 85, 86], "0721": 86, "073": [73, 76, 84, 86], "073655": 81, "074": [73, 76, 84, 85], "074814": 81, "075": [73, 76, 79, 84, 85], "075038": 81, "0754": 81, "075491": 82, "075799": 82, "0758": [82, 86], "075811": 82, "075866": 82, "0759": 86, "075965": 82, "076": [73, 75, 76, 82, 84, 85, 88], "07608": 82, "0761": 86, "076245": 82, "076246": 82, "076252": 82, "076266": 82, "076268": 82, "076281": 82, "076289": 82, "076296": 82, "076313": 82, "076338": 82, "076361": 82, "076424": 82, "076534": 81, "0766": 82, "076606": 82, "076641": 82, "076743": 82, "0768": 83, "0769": 88, "076915": 82, "077": [73, 76, 79, 84, 85, 96], "0772": [82, 86], "0774": 83, "0775510135829585": 76, "077690418635804": 3, "0777": 88, "078": [73, 76, 78, 79, 85, 86], "0781": [], "0783": 86, "078347": 82, "078348": 82, "078361": 82, "078446": 82, "07875": 82, "079": [73, 76, 84, 85], "079354": 82, "07953": 86, "079758": 85, "07ghz": [81, 83], "08": [73, 76, 81, 82, 84, 85, 86], "080": [73, 74, 76, 82, 84, 85], "08015": 82, "080441": 81, "08055": 86, "08057": 86, "08067": 86, "08069": 86, "080697": 81, "080738": 82, "08096": 86, "081": [76, 82, 84, 85, 86], "081075": 82, "081138": 82, "08118": 86, "081227": 82, "08125": 82, "081288": 82, "081303": 82, "081305": 82, "081315": 82, "081329": 82, "08134": 82, "081346": 82, "08135": 86, "081356": 82, "081358": 82, "081373": 82, "0814": 86, "081403": 82, "081412": 82, "08143": 86, "081442": 82, "081466": 82, "081471": 82, "08148": 86, "081515": 82, "081591": 82, "081722": 81, "081958": 81, "082": [73, 74, 76, 84, 85], "082035": 82, "082036": 82, "08205": 86, "08213": 86, "082152": 82, "08228": 82, "082315": 82, "082318": 82, "08254": 86, "08264": 86, "082715": 81, "08282": 86, "082836": 81, "08285": 86, "08299": 86, "083": [76, 82, 84], "08308": 82, "0832": 88, "083417": 82, "083513": 81, "08362": 86, "083698": 74, "0838": 85, "0839": [85, 86], "084": [76, 82, 84, 86], "08422": 86, "08427": 86, "08438": 86, "084417": 81, "08443": 86, "0847": 83, "084967": 81, "084969": 81, "08498": 81, "085": [73, 76, 84, 85], "085025": 81, "085115": 81, "085215": 81, "085247": 81, "085285": 81, "085337": 81, "085391": 81, "085475": 81, "085597": 81, "0856": 83, "085719": 81, "085801": 81, "085882": 81, "085887": 81, "085909": 81, "085958": 81, "086": [76, 84, 86], "086026": 81, "086068": 81, "08608": 81, "086115": 81, "086122": 81, "086136": 81, "086155": 81, "086176": 81, "086181": 81, "086195": 81, "086197": 81, "08649": 86, "08685": 86, "086918": 81, "087": [76, 82, 84], "088": [76, 84, 85, 86], "088252": 81, "089": [73, 76, 85], "09": [73, 74, 76, 78, 79, 81, 82, 84, 85, 86, 95], "090": [73, 76, 85, 86], "090391": 81, "091": [73, 78, 84, 85, 87], "0913": 88, "091952": 81, "092": 76, "092076": 81, "092555": 81, "093": [82, 84, 85], "093342": 81, "0934": 83, "093519": 81, "094": [76, 82, 84], "094318": 81, "094714": 81, "095": [76, 85, 86, 88], "09509": 81, "095596": 82, "095601": 82, "095677": 82, "096": [73, 84, 86], "096297": 82, "096504": 82, "096506": 82, "096656": 82, "096919": 81, "097": [76, 84, 85], "097393": 81, "09768": 82, "09771": 82, "097735": 81, "097838": 82, "098": 86, "098106": 82, "098364": 81, "09844": 82, "098888": 81, "098988": 81, "099": [73, 86, 88], "099929": 81, "1": [0, 1, 2, 3, 4, 6, 11, 14, 16, 17, 18, 21, 22, 29, 33, 34, 35, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 57, 59, 60, 62, 63, 64, 66, 68, 69, 70, 72, 73, 74, 76, 77, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96, 99], "10": [1, 11, 14, 15, 40, 41, 42, 43, 47, 51, 53, 54, 55, 56, 58, 59, 60, 63, 72, 73, 74, 75, 78, 79, 81, 82, 83, 84, 85, 86, 88, 95, 96], "100": [1, 18, 40, 41, 45, 47, 50, 51, 53, 54, 55, 58, 59, 60, 63, 72, 73, 76, 79, 81, 82, 84, 85, 86, 87, 88], "1000": [38, 47, 53, 54, 59, 60, 73, 82, 83, 85, 86], "10000": [64, 78], "1000000": [14, 23, 53, 59, 60], "10007": 82, "10009": 81, "1001": 82, "1003": [73, 82], "1005": 82, "1006": 82, "10087": 81, "1009": [73, 82], "100um": 63, "101": [73, 77, 82, 84, 86], "1010": 82, "1011": [81, 82], "101111": 86, "1012": 82, "101265": 86, "1013": [73, 82], "1014": 82, "101460": 86, "10162": 81, "10167": 81, "1017": [73, 82], "10172": 85, "10179": 81, "101813": 86, "10189": 84, "101e": [], "102": [73, 82, 84, 85, 86], "1020": 82, "102009": 86, "10213": 86, "10214": 86, "10215": 86, "10216": [], "10219": 81, "1022": [73, 82], "10220": 84, "10221": [81, 84], "10226": 86, "1024": 73, "10244": 81, "10246": 86, "10247": [], "1025": 82, "10252": 82, "1026": [73, 82], "1028": [84, 86], "1029": 84, "103": [40, 73, 82, 84, 85, 86], "1030": 82, "1031": [73, 86], "10312": 84, "1032": 82, "10324": 81, "1033": 83, "1034": [73, 82], "10341": 86, "10344": 84, "1035": 82, "1036": [11, 73, 82], "10363": 81, "1037": 82, "1038": [79, 82], "1039": 82, "10398": 81, "104": [73, 74, 75, 82, 84, 85, 86, 87], "1040": [11, 76], "10408": [81, 82], "1041": [82, 85], "10412": 84, "10416": 84, "1042": [82, 83], "1043": 82, "10448": 85, "1045": 82, "1046": [82, 83], "10463": [86, 87], "10467": [86, 87], "10469": 86, "1047": [81, 82, 83], "10472": [86, 87], "10473": [], "10474": [86, 87], "10475": [86, 87], "1048": 83, "10485670": [53, 59, 60], "1049": 83, "105": [73, 82, 84, 85, 86], "10505": [86, 87], "1051": 82, "10514": [86, 87], "1052": [83, 86], "10522": 86, "10525": 86, "10531": 86, "105342": 86, "1054": 76, "1056": 82, "1057": 82, "105712": 86, "105724": 86, "1058": 82, "1059": 73, "106": [74, 81, 82, 84, 86], "1060": [82, 83], "1061": [76, 82], "10617": 82, "10619": 82, "1062": [40, 84], "1063": [76, 82], "10635": 82, "10638": 86, "10639": 86, "1064": 86, "10641": 86, "10648": [86, 87], "1065": [76, 82], "1067": [82, 86], "106715": 86, "10673": 86, "10676": 86, "10677": 86, "10679": 82, "1068": [82, 88], "10686": 86, "10688": 86, "106889": 86, "106891": 86, "1069": 82, "10693": 86, "107": [73, 74, 82, 84, 86], "1070": 83, "10702": 82, "107089": 86, "107097": 86, "1071": 82, "1072": 73, "107264": [86, 87], "107277": 86, "1073": 82, "10730": 82, "1074": 82, "10746": 81, "10754": 85, "1076": [82, 86], "1078": 82, "1079": 82, "107999": 86, "108": [82, 84, 85, 86, 88], "1080": [53, 59, 60], "1081": [73, 81], "1082": 82, "108207": 86, "1083": [82, 83], "10841": 82, "1086": [82, 83], "10869": 83, "1087": 82, "10877": 83, "10878": 81, "10879": 83, "108857": 86, "10888": [86, 87], "10889": 83, "1089": 82, "109": [73, 81, 82, 84, 85, 86, 95], "1090": 82, "1091": [], "1092": 82, "1093": 81, "1094": [82, 83, 86], "1095": 82, "10956": 82, "1096": [81, 82], "10965": 81, "1097": [82, 83], "1099": 82, "11": [40, 73, 74, 76, 78, 81, 82, 83, 84, 85, 86, 87, 88, 95], "110": [73, 82, 84, 86], "1100": [81, 86], "1101": [73, 82], "1103": 82, "11037": 81, "1104": [76, 81, 82, 85], "1105": 83, "1106": 82, "1107": [11, 47, 53, 59, 60, 75], "11078": 81, "1108": 84, "1109": 82, "11094": 86, "111": [73, 74, 76, 81, 82, 84, 86, 95], "1110": [82, 84], "11116": 81, "1112": 73, "1112402970091422": 76, "11128": 81, "1114": 73, "11146": 81, "1115": 73, "1116": 82, "1119": [], "112": [81, 82, 85, 86], "1120": [40, 82, 84, 86], "11202": 85, "11206": [], "11207": 86, "1121": [73, 82, 86], "1122": 82, "1123": 82, "11241": 82, "1125": 81, "1126": 82, "112674": 86, "1127": [40, 84], "1128": [81, 84], "1129": [82, 84], "113": [74, 76, 81, 82, 86], "1130": [82, 83, 86], "1131": [81, 82], "1132": 82, "1133": 85, "11336": 81, "11345": 81, "1135": 86, "113599": 86, "113621": 86, "113637": 86, "11368": 81, "1137": 82, "113784": 86, "113803": 86, "113865": 86, "113880": 86, "113906": 86, "11391": 81, "113913": 86, "113958": 86, "113990": 86, "114": [73, 82, 84, 85, 86], "1140": 82, "114013": 86, "114017": 86, "114024": 86, "114060": 86, "114065": 86, "1141": 82, "114109": 86, "114110": 86, "114113": 86, "114123": 86, "114124": 86, "114137": 86, "114140": 86, "114144": 86, "114150": 86, "114151": 86, "114154": 86, "114178": 86, "114191": 86, "114199": 86, "1142": 83, "114207": 86, "114214": 86, "114230": 86, "11424": 82, "114242": 86, "114243": 86, "114265": 86, "114266": 86, "114275": 86, "114277": 86, "114292": 86, "114325": 86, "114431": 86, "114470": 86, "114482": 86, "1145": 82, "114507": 86, "114518": 86, "114543": 86, "114555": 86, "11457": 86, "11465": 84, "1147": 84, "1148": [81, 84], "114816": 86, "11484": 84, "1149": 76, "115": [74, 82, 86, 88], "1150": 82, "1152": 83, "1154": 82, "1155": 86, "1156": 82, "11564": 81, "116": [73, 78, 82, 86], "1161": 82, "11626": 83, "1165": 82, "1166": 82, "1167": [82, 86], "1168": 86, "117": [74, 82, 84, 85, 86], "1171": [84, 86], "11716": 81, "1172": [82, 83], "1173": 82, "1174": [81, 84], "1175": [81, 82], "1176": 81, "1177": 86, "11775": 81, "1178": [81, 82], "11794": 87, "118": [74, 78, 82, 86], "1180": 82, "1181": 86, "1182": 82, "11826": 81, "1183": [84, 86], "11833": 86, "11836": 81, "1184": 84, "11840": 84, "1185": 82, "11851": 81, "1186": [82, 86], "1187": 86, "1188": 82, "1189": [81, 82, 84, 86], "11892": 84, "119": [78, 81, 82, 84, 86, 96], "1190": [83, 85], "11907": 81, "1191": [82, 84, 86], "11915": 81, "11927": 84, "1193": [82, 84], "1194": 82, "11943": 82, "1195": 82, "1197": [84, 86], "11972": 81, "11975": 81, "1198": [82, 86], "1199": 82, "12": [11, 40, 73, 74, 76, 78, 81, 82, 83, 84, 85, 86, 88], "120": [0, 1, 45, 46, 47, 50, 51, 78, 82, 84, 86, 87, 96], "1200": [83, 84], "1201": 86, "120152": 79, "1202": 82, "12029": 81, "1203": [76, 82], "1204": [82, 86], "1205": [83, 86], "1207": [82, 84], "1208": [82, 84, 86], "1209": [82, 84, 86], "121": [11, 73, 76, 77, 78, 82, 84, 86], "1210": [81, 83, 86], "1211": 83, "1212": [76, 84], "12121": 81, "1213": 84, "1214": [82, 86], "12145": 81, "121474": 82, "12164": 81, "12167": 81, "1217": [82, 85, 86], "1219": [82, 86], "12198": 88, "122": [73, 76, 78, 82, 84, 86], "1220": [76, 86], "1221": [76, 82, 84, 86], "1222": [81, 82, 86], "1223": [82, 86], "12234": 81, "1224": 84, "12248": 82, "1225": [82, 84], "1226": [82, 84, 86], "1227": [82, 84], "1228": 86, "12280": 82, "12281": 82, "1229": [84, 86], "12291": 81, "123": [40, 73, 78, 82, 84, 86], "1230": [84, 88], "1231": [82, 84, 86], "12311": 84, "1232": [81, 83], "12326": 84, "1233": [82, 84, 86], "1234": [49, 86], "1235": 86, "1236": 82, "12373": 84, "1238": [82, 86], "12386": 84, "124": [73, 74, 76, 78, 82, 84, 85, 86], "1240": [82, 86], "1241": 82, "1242": [82, 86], "1243": [81, 82], "12431": 81, "1245": 86, "1248": [82, 86], "12494": 81, "124946": 86, "12495": 81, "125": [0, 73, 76, 78, 81, 82, 84, 85, 86], "1252": [82, 86], "12524": 84, "12527": 84, "12528": 81, "1253": [82, 86], "1254": 82, "12543": 81, "12546": 84, "1255": [82, 86], "1256": [82, 84, 86], "12568": 86, "1257": [82, 86], "1258": [82, 84, 86], "12582": 81, "1259": [82, 86], "126": [0, 2, 73, 78, 82, 84, 86], "1261": [83, 86], "12612": 81, "12619": 82, "1262": 86, "1263": [82, 86], "1264": [82, 86], "12647": 81, "1265": 86, "1266": 82, "1267": 86, "1268": [82, 86], "1269": [84, 86], "12695": 85, "127": [73, 76, 78, 81, 82, 84, 86], "1270": 86, "1271": [84, 86], "1273": [82, 86], "12735": 81, "1274": 95, "1275": [86, 88], "1276": [82, 86], "12769": 95, "1277": [84, 86], "12774": 81, "1278": [76, 82, 86], "128": [73, 76, 78, 81, 82, 84, 86], "1281": [82, 86], "12815": 81, "1282": 86, "1283": 82, "12831": [], "12834": 86, "1284": [40, 82, 84, 86], "12845": 81, "1285": [82, 86], "1286": [81, 82, 86], "128604": 86, "1287": [82, 86], "1288": [82, 86, 88], "1289": 86, "129": [73, 76, 78, 82, 84, 86], "1290": 86, "12908": 86, "1291": [82, 86], "12917": 84, "1292": [82, 86], "1293": [85, 86], "12934": 81, "1294": 86, "12942": 81, "1295": 86, "1296": [82, 86], "1297": [82, 83, 86], "12970": 86, "1298": [82, 86], "12987": 82, "129876": 82, "1299": [81, 86], "12th": 99, "13": [40, 73, 74, 76, 77, 81, 82, 83, 84, 85, 86, 96], "130": [76, 78, 82, 86], "1300": [82, 86], "13001": 81, "1301": 82, "13032": 82, "1304": 86, "1305": 82, "1306": 86, "1307": [82, 86], "130748": 82, "130749": 82, "1308": [82, 83], "130878": 82, "1309": [82, 86], "130920": 82, "130947": 82, "130961": 82, "130988": 82, "131": [76, 78, 81, 82, 86], "1310": 86, "131032": 82, "131069": 82, "131072": 82, "131075": 82, "1311": 86, "131102": 82, "131107": 82, "131138": 82, "131143": 82, "131181": 82, "1312": 86, "131244": 82, "131286": 82, "131302": 82, "131333": 82, "131360": 82, "131363": 82, "131398": 82, "131446": 82, "13145": 76, "131474": 82, "131478": 82, "1315": 86, "131503": 82, "131505": 82, "131546": 82, "131547": 82, "131553": 82, "131574": 82, "1316": 82, "131615": 82, "131653": 82, "131689": 82, "131699": 82, "1317": 86, "131706": 82, "131708": 82, "131729": 82, "131757": 82, "131784": 82, "1318": 86, "131818": 82, "131849": 82, "1319": 86, "131909": 82, "131936": 82, "131949": 82, "13198": [86, 87], "132": [0, 76, 78, 81, 82, 84, 85, 86], "1320": 86, "132001": 82, "132052": 82, "1321": [82, 86], "1322": 86, "1323": [82, 86], "1324": 86, "1325": [82, 86], "13252": 83, "13254": 83, "13258": 83, "1326": [83, 86], "13260": 84, "13265": 83, "1327": [82, 86], "13279": 82, "1328": [82, 86], "13282": [83, 88], "13283": 84, "13299": 82, "133": [81, 82, 84, 86], "1331": [83, 86], "1332": [82, 86], "1333": 86, "1334": [82, 83], "13349": 82, "1335": [82, 86], "13354": 84, "1336": [82, 83], "1337": [82, 86], "13375": 81, "1338": [82, 86], "1339": [82, 86], "13392": 84, "134": [76, 78, 81, 82, 84, 85, 86], "1340": [82, 86], "1341": 86, "13413": [86, 87], "1342": 82, "1343": [82, 86], "134383": 74, "1344": [82, 86], "1345": [82, 86], "13459": 81, "1346": 86, "1347": [82, 86], "13476": [86, 87], "1348": 86, "1349": 86, "135": [76, 81, 82, 86], "1350": [82, 86], "1351": [82, 86], "1352": 86, "1353": 86, "13534": 83, "1354": [82, 86], "1355": 86, "13559": 81, "1356": 86, "1357": 86, "1358": [83, 86], "13596": 84, "136": [0, 2, 73, 78, 82, 84, 85, 86, 96], "1360": 82, "1360324992": 3, "1360324993": 3, "1360324994": 3, "1361": [73, 81, 82], "1362": [82, 86], "1363": [81, 86], "1364": [83, 86], "1365": 82, "1366": [82, 86], "1367": 86, "1368": 86, "1369": 86, "137": [73, 74, 82, 84, 85, 86, 88], "1371": 86, "1372": 82, "13728": 81, "1373": [73, 86], "13737": 81, "1374": 86, "1375": 86, "13758": 84, "1376": 86, "1377": 83, "1379": [82, 86], "138": [82, 85, 86], "1380": [84, 86], "13802": 84, "1381": [82, 83, 86], "13814": 86, "1382": 86, "1383": [82, 86], "13833": 85, "1384": [82, 86], "1385": [82, 86], "1387": 82, "1388": 86, "13887": 81, "1389": [82, 86], "139": [76, 82, 85, 86], "1390": 86, "1391": [82, 86], "1392": 82, "1393": [82, 86], "13937": 84, "1394": 86, "1396": 81, "1397": [81, 86], "1398": 86, "1399": [82, 83, 86], "13_integr": 79, "13th": 99, "14": [3, 40, 73, 74, 76, 81, 82, 83, 84, 86, 95], "140": [73, 76, 81, 82, 84, 86], "1400": 95, "1401": 82, "1403": 86, "1404": [40, 82, 84, 86], "1405": 86, "1406": 86, "1407": [82, 84, 86], "14071": 76, "1408": [82, 84, 86], "1409": 86, "141": [76, 82, 84, 85, 86], "1410": [82, 86], "14108": 81, "1411": [82, 86], "1412": 82, "14121": 84, "14122e": 82, "1413": [83, 86], "1414": [82, 86], "1415": 86, "1416": 86, "14168": 81, "1417": [82, 86], "1418": [82, 86], "1419": [82, 86], "142": [73, 76, 82, 84, 86], "1420": [82, 86], "1421": [82, 86], "1422": [82, 83], "1423": 86, "1424": [82, 86], "1425": [82, 86], "1426": 86, "1427": [82, 86], "1428": [73, 82], "1429": [82, 83, 86], "143": [82, 84, 86], "1430": [82, 83, 86], "14306": 81, "1431": 86, "1432": [82, 86], "1433": [82, 86], "14334": 86, "14339": 81, "1434": 86, "1435": [82, 86], "1436": [82, 84, 86], "1437": 86, "14379": 81, "1438": [83, 86], "1439": 86, "14397": 84, "144": [74, 76, 82, 86], "1440": [82, 86], "1441": 86, "1442": 86, "1444": 86, "1445": [82, 86], "1447": [82, 86], "14476": 81, "1448": 86, "1449": 82, "145": [0, 73, 76, 81, 82, 84, 86], "1451": 82, "14510": 82, "1452": [82, 86], "1453": 86, "1454": [82, 83, 86], "1455": 86, "1456": 86, "1457": 86, "1458": [82, 86], "1459": [86, 95], "146": [73, 81, 82, 84, 86], "1460": 86, "1461": 86, "14610": 82, "14619": 82, "1462": [82, 83, 86], "1463": [82, 86], "1464": [82, 83, 86], "1465": [86, 95], "14653": 81, "1466": 86, "1467": [83, 86], "14673": 81, "14677": 84, "14678": 84, "14689": 81, "1469": 86, "147": [73, 82, 86], "1470": [82, 86], "1471": [83, 86], "1472": [83, 86], "1473": [82, 83, 86], "1474": [81, 82, 86], "1475": 86, "14752": 85, "1476": [82, 86], "14767": [], "14768": 86, "1477": [82, 83, 86], "1478": [81, 86], "14785": 81, "1479": 82, "148": [73, 76, 81, 82, 84, 86], "1480": 86, "14804": 86, "1481": 83, "1482": 86, "1484": 86, "14842": 81, "1485": 86, "1486": 82, "1487": 82, "148799": [40, 84], "1488": [82, 86], "1489": [82, 86], "149": [73, 76, 79, 82, 84, 86], "1490": [78, 86], "1491": [82, 86], "1492": 86, "14920": 82, "1493": [82, 86], "1495": 82, "1496": 82, "1497": 86, "1498": [78, 86], "1499": 86, "15": [14, 40, 53, 54, 63, 73, 76, 81, 82, 83, 84, 85, 86], "150": [47, 53, 54, 63, 69, 72, 73, 79, 81, 82, 84, 85, 86, 87], "1500": [82, 86], "15001": 81, "15006": 81, "1501": 86, "1502": 86, "1503": [82, 86], "15033": 81, "15038": 81, "1504": 86, "1505": [82, 86], "1506": [85, 86], "15064": 87, "15067": 82, "1507": [81, 82, 86], "15071": 82, "1508": [78, 83, 86], "1509": [82, 86], "151": [73, 76, 81, 82, 84, 85, 86], "1510": 86, "1511": [81, 86], "1512": [81, 82, 86], "151254": 86, "1513": 86, "1514": 82, "15140": 76, "15145": 82, "1515": 86, "15151": 81, "15165": 85, "1518": 86, "1519": 86, "151986": [], "151988": 86, "152": [78, 81, 82, 84, 86], "1520": 86, "1521": 86, "1522": 82, "1523": 86, "1524": 82, "1526": 86, "1527": 82, "1528": 86, "15287": 82, "1529": [83, 86], "15295": 81, "153": [76, 78, 81, 82, 84, 86], "1530": [82, 86], "1531": 86, "1532": 86, "15320": 76, "15323": 81, "1533": [82, 86], "1534": [82, 86], "1535": [78, 86], "1536": [82, 86], "15365": 81, "1537": 86, "15371": 86, "15376": 83, "1538": [85, 86], "1539": 85, "15398": 82, "154": [74, 76, 78, 81, 82, 85, 86], "1540": 86, "15417": 81, "1542": 86, "15427": 81, "1544": 82, "1545": 86, "1546": 86, "15463": 81, "1547": 81, "1549": 86, "155": [73, 76, 81, 82, 84, 86], "1550": [81, 86], "1551": [83, 86], "1552": 86, "1553": 86, "15548": 82, "1555": [82, 86], "15575": [86, 87], "1558": 86, "15582": 85, "15589": 81, "1559": 86, "155e": 82, "156": [76, 82, 84, 86], "1560": [78, 86], "1561": 82, "1562": [78, 82, 86], "156241": [], "156242": 86, "1563": [82, 83, 86], "1564": 86, "15652": 82, "1566": 86, "1568": 86, "1569": [83, 86], "157": [3, 76, 82, 84, 86], "1570": [83, 86], "15719": 82, "1572": 86, "1573": [78, 86], "1574": 86, "1575": 86, "1576": [82, 86], "1576060": 78, "1577": 86, "15776": [81, 82], "1578": 82, "1579": 86, "15798": 73, "158": [73, 76, 81, 82, 84, 86], "1580": 86, "1581": [83, 86], "15812": 82, "1582": 86, "15826": 82, "1583": [86, 88], "1584": [78, 86], "158400": 76, "15842": 82, "1585": 86, "1586": [82, 86], "1587": [83, 86], "1588": [83, 86], "1589": [81, 86], "159": [78, 82, 83, 84, 86], "1590": 82, "1591": 86, "1592": 82, "1593": 86, "1594": 86, "1596": 86, "1597": 86, "15973": 73, "1598": [82, 86], "1599": 86, "16": [3, 40, 48, 73, 74, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 95], "160": [73, 82, 84, 85, 86], "16001": 82, "1601": 86, "16016": 81, "16023": 82, "1603": 86, "1605": 86, "16051": 82, "1606": 86, "1608": 86, "1609": 86, "161": [73, 76, 82, 84, 86], "1610": 86, "1611": 82, "1612": 86, "16125": 81, "1613": 86, "16130": 81, "1614": 86, "16140": 82, "1615": [75, 86], "1616": 82, "1617": 86, "1618": 86, "16185": 81, "1619": [73, 86], "16199": 83, "162": [78, 81, 82, 83, 84, 86], "16204": 83, "16205": 73, "1621": [82, 86], "16213": 83, "16217": 84, "16219": 84, "1622": 86, "16223": 83, "1623": [82, 86], "16236": 84, "16239": 81, "16240": 84, "1625": [82, 86], "16252": 83, "1626": [81, 85, 86], "1627": 86, "1628": 86, "16285": 84, "16288": 81, "1629": 86, "163": [76, 82, 84, 86], "1630": [81, 82, 86], "1631": 86, "1632": [81, 85, 86], "1633": 86, "1634": [82, 86], "1635": 86, "1636": 86, "1637": 86, "16373": 81, "16379": 81, "1638": 86, "164": [73, 76, 82, 84, 86], "1640": 86, "1641": 86, "1642": 83, "1643": 86, "1644": 86, "1645": [83, 86], "1646": 86, "1648": [82, 86], "1649": 86, "16491": 81, "165": [76, 82, 84, 86], "1650": 86, "1651": 82, "1653": 86, "16534": 84, "1654": [82, 83], "16541": 84, "1655": [82, 86], "1656": 86, "16563": 76, "1657": 86, "16573": 85, "1658": 86, "1659": 86, "16592": 85, "166": [73, 82, 85, 86, 96], "1660": 86, "166095": 84, "1661": [82, 86], "1662": [82, 86], "1663": 86, "16635": 85, "16636": 85, "1664": 86, "16640": 76, "16646": 81, "1665": 86, "1666": 82, "1667": 82, "16670": 84, "16674": 84, "16676": 84, "1668": [82, 86], "167": [73, 78, 82, 84, 86], "1671": 86, "1672": [82, 86], "167233": 76, "167255": 82, "16728": 81, "1673": 86, "16738": 86, "1674": 86, "1676": 86, "16762": 83, "1677": 86, "1678": 86, "1679": 86, "167e": 81, "168": [73, 82, 84, 86, 88], "1680": 86, "1681": 86, "1682": 86, "1683": 86, "16869": 81, "1687": 86, "16875": 82, "1688": 86, "1689": 86, "169": [73, 76, 82, 84, 85, 86], "169055": 82, "1692": 86, "1693": 86, "1694": 86, "16949": 82, "1695": [83, 86], "16954": 81, "1696": [83, 86], "16967": [81, 82], "1697": [82, 86], "1698": 86, "1699": 86, "17": [73, 74, 76, 79, 81, 82, 83, 84, 85, 86, 95], "170": [73, 76, 82, 84, 86], "1700": 83, "1701": [49, 86], "1702": 86, "1702991": 78, "1703": [82, 86], "1704": 82, "1705": [82, 86], "17067": 81, "1707": 86, "17078": 81, "17079": 83, "1708": 86, "1709": 86, "17099": 81, "171": [78, 82, 84, 85, 86], "1710": 86, "1711": 86, "1712": 86, "17122": 95, "1713": 86, "17132": 84, "17133": 84, "1715": 86, "1716": 86, "1717": 86, "17174": 82, "17175": 81, "1719": 86, "172": [3, 78, 82, 84, 86], "1720": 82, "1721": 86, "1722": 86, "1723": 86, "172395": 82, "1724": [82, 86], "17247": 85, "17249": 85, "1725": 85, "17253": 81, "17261": 81, "1727": [83, 86], "1728": [85, 86], "1729": [82, 86], "172960": 82, "173": [73, 74, 82, 86], "1730": 86, "173009": 82, "1731": [82, 86], "1732": 86, "1734": [82, 83, 86], "1735": 86, "17357": 81, "1736": 86, "1738": [83, 86], "1739": [81, 82], "174": [82, 84, 86], "1740": 86, "1741": [82, 86], "17418": 81, "1742": [82, 86], "174263": 82, "1743": 82, "1744": 86, "17440": 82, "1745": 82, "174532": 82, "174581": 82, "1746": [81, 82, 86], "1747": 86, "174758": 82, "17479": 82, "17482": 82, "1749": [81, 86], "175": [73, 81, 82, 86], "1750": 86, "1751": 86, "1752": [82, 86], "1753": 86, "17531": 85, "17534": 81, "1754": 86, "1755": 82, "1756": [83, 86], "1758": 86, "1759": 84, "176": [82, 84, 85, 86], "1760": 86, "17610": 82, "1761030": 78, "1762": [82, 86], "176235": 82, "1763": 86, "1764": [84, 86], "1765": 86, "176558": 82, "1769": 86, "177": [73, 81, 82, 84, 86], "1770": 86, "17706": 81, "1772": [81, 82, 84], "1773": 82, "1774": [84, 86], "1776": 86, "1777": 86, "17776": 82, "178": [73, 78, 82, 84, 86], "1781": 86, "1782": [82, 86], "1783": 86, "1784": [82, 86], "17851": 81, "1786": [83, 86], "17861": 81, "17864": 81, "17869": 86, "1787": [82, 86], "17887": 95, "179": [82, 86], "1790": 86, "1792": 82, "1794": 86, "1795": [82, 86], "1796": 85, "17961": 81, "1798": [82, 86], "1799": 86, "18": [53, 59, 60, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 95], "180": [53, 73, 76, 82, 84, 86], "1800": 85, "18025": 81, "1803": 81, "1805": 86, "1806": 81, "180658": 85, "1807": [82, 86], "181": [82, 84, 86], "1810": 86, "1812": 85, "1814": 83, "1817": 81, "1818": 86, "182": [82, 84, 85, 86, 95], "1820": 86, "18212": 81, "1822": 86, "18238": 81, "18246": 82, "18268": 82, "18283": 81, "18285": 82, "18292": 82, "18294": 82, "183": [82, 84, 86], "1830": 83, "1833": 82, "18338": 81, "18343": 82, "1835": 84, "18353": 81, "1836": [84, 86], "1837": [82, 84], "1838": [82, 86], "184": [73, 82, 84, 86], "1841": 86, "1842": [82, 86], "1843": [74, 86], "18439": 81, "1844": 88, "1845": 85, "18454": 81, "18468": 81, "1848": 82, "185": [73, 76, 82, 86, 87], "1851": 86, "1852": 86, "1853": 82, "1856": 83, "1859": 85, "186": [73, 76, 79, 82, 86], "18605": 82, "186145": 81, "186203": 81, "18643": 81, "1865": 86, "18662": 81, "1868": 86, "1869": 84, "187": [76, 82, 86], "1870": [81, 85], "18709": 81, "1871": [82, 86], "1872": 81, "1873": [82, 85], "1875": 82, "1876": [81, 84], "18766": 82, "1879": 86, "188": [82, 84, 86], "1881": 81, "18814": 81, "1883": [82, 86], "18836": 84, "18839": 86, "18862": 81, "1887": 86, "18887": 81, "189": [73, 82, 85, 86], "1890": [75, 86], "18919": 84, "1893": 86, "1894": 86, "1896": 86, "1897": 86, "18971": 81, "19": [40, 73, 78, 79, 81, 82, 83, 84, 85, 86, 87, 90, 95], "190": [73, 79, 82, 84, 86], "1900": 86, "19024": 86, "1903": 86, "19032": 73, "19036": 81, "1904": 86, "1907": 81, "19084": 81, "191": [82, 86, 96], "19105": 81, "1912": [81, 86, 95], "1913": 86, "19137": 81, "1914": 86, "19154": 81, "19159": 73, "1916": 86, "1917": 84, "19172": 84, "19177": 73, "19181": 81, "192": [3, 73, 76, 82, 84, 86], "1920": [82, 86], "1921": 95, "19222": 81, "1923": 82, "1924": 81, "19246": 81, "19257": 81, "192715": 81, "1928": 86, "1929": 83, "193": [74, 76, 82, 86], "1930": [82, 86], "1931": 81, "1932": 86, "1933": 86, "193373": 82, "1934": [81, 82, 86], "19349": 81, "1935": 87, "1937": 86, "194": [45, 46, 47, 50, 51, 73, 82, 84, 86], "1940": 86, "19437": 81, "19453": 81, "1947": 86, "19485": 81, "1949": 86, "19499": 81, "195": [73, 78, 82, 84, 86], "1950": 86, "1951": 81, "1955": 82, "19581": 86, "19583": [], "196": [76, 82, 84, 86], "1963": 82, "1965": [81, 86], "19655": 81, "1967": 2, "1969": 82, "197": [82, 84, 85, 86], "1976": 97, "1979": 86, "198": [76, 82, 86], "1982": [18, 40, 84], "19848": 81, "19856": 81, "1986": [11, 86, 97], "19861": 81, "1987": 0, "198714": 82, "199": [2, 73, 81, 82, 84, 85, 86], "1992": [2, 95], "19928": 78, "1993": 81, "199395": 82, "1994": 81, "1995": [82, 97], "1997": [11, 53, 81, 86], "1998": [11, 83], "19984": 81, "1999": [2, 53, 54, 59, 60, 84, 86, 95], "1_integr": 63, "1a": 63, "1d": [11, 53, 82, 86, 87], "1e": [14, 18, 23, 24, 25, 38, 41, 44, 51, 54, 58, 63], "1e6": 63, "2": [0, 1, 2, 3, 4, 7, 11, 14, 16, 18, 22, 33, 35, 38, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 58, 59, 60, 61, 62, 63, 64, 66, 68, 69, 72, 73, 74, 76, 78, 79, 80, 81, 83, 84, 85, 86, 87, 88, 95, 96, 99], "20": [11, 14, 16, 38, 40, 41, 46, 47, 48, 51, 53, 54, 58, 59, 60, 63, 66, 72, 73, 74, 75, 78, 79, 81, 82, 83, 84, 85, 86], "200": [47, 50, 53, 54, 63, 69, 72, 73, 76, 82, 84, 85, 86], "2000": [63, 72, 82, 85], "20000": [77, 78, 82, 86], "20011": 85, "2002": [0, 2, 82], "20037": 84, "2004": [11, 35, 64, 84], "2005": 83, "2006": [2, 18, 69], "20061": 81, "2007": 0, "2008": 86, "201": [73, 76, 81, 82, 86], "2010": [0, 53, 59, 60, 79], "2011": [18, 69, 79, 95], "2012": [92, 95, 99], "2013": [95, 99], "20130324": 95, "20130590": 95, "2014": [11, 40, 84, 95, 99], "20149": 81, "2015": [95, 99], "2015_11_10": 48, "2016": [83, 95], "2017": [40, 95], "20171": 81, "20176": 81, "2018": [18, 40, 75, 79, 84, 95], "20187": 81, "2019": [85, 95], "202": [82, 86], "2020": [11, 35, 82, 84, 86, 95], "2021": [73, 74], "2022": [72, 84, 92, 95], "2024": 84, "20247": 81, "20254": 84, "2029": 82, "203": [73, 81, 82, 84, 85, 86], "20310": [], "20311": 86, "20324": 76, "2033": 83, "20340": 81, "20347": 83, "20368": 76, "203702": 84, "203731": 84, "2038": 83, "20382": 84, "2039": 86, "20394": 84, "20395": 84, "204": [78, 82, 86], "2040": 82, "20401": 81, "20413": 84, "20427": 86, "2043": 81, "2044": 86, "20449": 84, "2045": 86, "20450": 86, "2047": 86, "2049": [82, 86], "205": [2, 73, 76, 78, 81, 82, 84, 86], "20518": 84, "20519": 84, "2052": [82, 86], "20521": 81, "2053": 86, "20533": 84, "2055": 75, "20587": 85, "20596": 86, "206": [82, 86], "20604": 86, "20606": 84, "2061": 81, "2063": [82, 83], "2065": 82, "2066": 86, "20673": 84, "20676": 81, "20682": 84, "20683": 84, "20684": 84, "2069": [82, 86], "20695": 81, "20696": 81, "207": [75, 82, 84, 86], "20700": 84, "2071": 82, "2076": 86, "20760": 86, "2077": 86, "20779": 86, "20789": 84, "20791": 78, "20793": [81, 84], "20798": 84, "20799": 84, "208": [73, 78, 82, 86], "20815": 82, "20816": 81, "20817": 82, "20821": 81, "20824": 84, "20831": 84, "20834": 81, "20836": 82, "2084": 75, "20848": 81, "2085": 86, "20874": 82, "20887": 82, "20899": 82, "209": [82, 84, 86], "20903": 82, "20905": 82, "20908": 84, "20916": 84, "20917": 84, "20924": 82, "20929": 82, "20934": 82, "20935": 82, "20936": 82, "20938": 82, "20941": 82, "20942": 82, "20943": 81, "20944": [82, 84], "20945": 86, "20949": [82, 86], "2095": [], "20950": 82, "20952": 82, "209577": 85, "20958": 82, "20961": 82, "20964": 82, "209642": 85, "209657": 85, "20966": 82, "20967": 82, "209673": 85, "2097": 86, "20971": 82, "209715": 85, "20972": 82, "209725": 85, "20973": 82, "209735": 85, "20974": 82, "20975": 82, "20976": 82, "20977": 82, "209773": 85, "209775": 85, "20978": 82, "209787": 85, "20979": 82, "20982": 82, "20983": 82, "20984": 82, "20985": 82, "20986": 82, "20988": 82, "2099": 82, "20990": 82, "20992": 81, "20999": 82, "20e": 84, "20k": 1, "20th": [47, 54, 63, 66, 69, 72], "21": [73, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88], "210": [78, 82, 86, 87], "21000": 82, "21001": 82, "21005": 82, "2101": 86, "21012": 82, "21022": 82, "21025": 82, "21027": 82, "21028": 82, "21029": 82, "21033": 82, "21039": 82, "2104": 86, "21047": 81, "2105": [82, 86], "21054": 82, "21058": 82, "21088": 81, "21094": 82, "211": [3, 82, 85, 86], "2111": [81, 86], "21115": 84, "21127": 84, "21128": 84, "21131": 82, "21137": 84, "2114": 83, "21140": 86, "2115": [84, 86], "21163": 82, "21167": 81, "21172": 84, "21178": 82, "21179": 81, "2118": 82, "2119": 84, "21193": 81, "212": [73, 78, 82, 84, 86], "21208": 82, "21212": 82, "21221": 82, "21222": 76, "2123": 86, "21237": [], "21238": 86, "2125": [74, 84], "2127": 86, "21271": 82, "2128": 82, "21281": 86, "21289": 84, "2129": 82, "213": [73, 76, 82, 84, 86], "2130": 86, "21300": 84, "21302": 84, "21324": 81, "21338": 86, "2134": 86, "21351": 81, "21355": 86, "21363": 76, "2137": [81, 86], "21371": 86, "2138": 81, "21382": 81, "21387": 81, "213880": 85, "2139": 83, "214": [78, 82, 84, 86], "21401": 76, "21403": 81, "21412": 84, "21416": 86, "21418": 84, "21419": 84, "21423": 81, "21426": 81, "2143": [85, 86], "21432": 86, "21436": 81, "21443": 81, "21449": 86, "2145": 82, "21454": 81, "21460": 86, "21465": 81, "2147": 86, "2149": 86, "215": [78, 82, 84, 86], "2150": 86, "21502": 81, "21506": 81, "21507": 86, "21529": 86, "2153": 83, "21540": 76, "2157": [82, 86], "2159": 86, "216": [82, 86], "21635": 81, "21636": 76, "21637": 76, "21639": 76, "21649": 76, "21656": [81, 86], "2166": 81, "2168": [82, 86], "216892": 84, "21691": 81, "216938": 84, "217": [82, 84, 86], "2171": 86, "21713": 82, "2173": 83, "21735": 81, "21740": 82, "21747": 83, "21759": 86, "2176": [81, 82], "21765": 82, "2177": 82, "2178": 73, "21781": 86, "2179": 82, "21795": [82, 84], "218": [73, 82, 86], "2180": 83, "21806": 82, "218080": 86, "21809": 82, "21821": 82, "21822": 82, "21823": 81, "21826": [82, 86], "218270": 90, "2183": 82, "21831": 82, "21832": 82, "21833": 82, "218334": 86, "2184": 82, "21844": 82, "21845": 82, "2185": 86, "21858": 81, "2186": 86, "2187": 82, "2188": 86, "21889": 82, "2189": 76, "21894": 81, "21896": 82, "219": [3, 73, 82, 84, 86], "219058": 84, "2191": 86, "219140": 84, "219144": 84, "21923": 81, "21926": 81, "2193": [74, 86], "21934": 82, "2194": [40, 82, 84], "21948": 82, "21959": 86, "2197": 79, "2198": 86, "21992": 86, "21a": [84, 85], "21b": 85, "21c": 85, "22": [2, 3, 73, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 95, 96], "220": [73, 82, 84, 86], "2202": 82, "22074": 82, "2208": 85, "22084": 76, "22093": 81, "221": [82, 86, 96], "2211": 86, "22117": 86, "22118": 81, "2213": [82, 86], "2215": 86, "22177": 86, "22185": 86, "22193": 81, "222": [75, 76, 82, 84, 85, 86], "22206": 86, "2223": 86, "22246": 81, "222563": 84, "2226": 83, "2227": 83, "22282": 86, "22294": 86, "223": [73, 82, 86], "2230": 86, "2231": 81, "22329": 81, "2234": [82, 86, 87], "2235": [81, 86], "22352": 81, "2236": 82, "2237": [82, 85], "2238": 82, "224": [73, 81, 82, 86], "22401": 86, "2242": 86, "22424e": 86, "22429": 86, "2243": [82, 86], "2244": 86, "22443": 81, "2246": 82, "2247": 82, "22476": 86, "22482": 81, "2249": [], "225": [73, 76, 82, 85, 86], "2250": [82, 86], "2251": 82, "2252": [81, 82], "2253": 82, "22531": 81, "225340": 86, "2254": 81, "2255": [82, 85], "22555": 76, "22562": 82, "22587": 81, "2259": 82, "226": [76, 82, 86], "2260": [82, 86], "22605": 82, "22611": 81, "22620": 86, "2263": 86, "22640868": 95, "2266": 82, "22665786": 95, "22668": 81, "2268": 82, "2269": 86, "22699": 86, "227": [76, 81, 82, 85, 86], "2270": [81, 85], "2271": 81, "22713": 81, "2272": [82, 85], "22722": 81, "22740": 81, "2275": 82, "22761": 81, "22762": 86, "22771": 86, "22778": 86, "2278": 86, "22785": 86, "228": [82, 84, 86], "2282": 86, "22837": 82, "2284": 82, "228434": 86, "2285": 85, "2288": [85, 86], "2289": 81, "229": [82, 86], "2290": 82, "22907": 86, "22936": 81, "22938": 86, "2294": 86, "22943": 76, "22949": 86, "2295": 86, "22951": 86, "2296": 86, "2298": 82, "2299": 82, "22nd": 99, "23": [40, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86], "230": [40, 69, 82, 86], "23008": 86, "2301": 86, "2302": 86, "23046": 86, "2306": [85, 86], "2308": 86, "23081": 81, "2309": 82, "231": [76, 81, 82, 84, 86], "23105": 81, "23108": 82, "2311": 86, "2312": 82, "23127": 81, "2313": 82, "2315": 86, "2316": 82, "2317": 81, "2319": [82, 86], "232": [73, 82, 83, 86, 95], "23215": 81, "2327": 82, "23278": 86, "23289": 81, "2329": 86, "233": [82, 86], "2330": 83, "2331": 81, "23317": 78, "2332": [82, 86], "2333": [82, 86], "23331": 82, "2334": 83, "23343": 82, "2338": 86, "23386": 82, "23389": 81, "23395": 81, "234": [82, 86], "23402": 82, "23403": 82, "2341": 86, "23413188": 95, "2342": [82, 86], "23437": 81, "2344": 86, "2346": 81, "2347": [82, 86], "2348": 81, "23485": 81, "2349": 86, "23494": 81, "23495": 81, "235": [79, 82, 85, 86], "2350": 84, "23507": 85, "2351": 82, "2352": [82, 86], "23529": 86, "2354": 86, "2355": 86, "23553": 81, "2356": 86, "2357": 86, "2358": 86, "2359": 81, "236": [81, 82, 86], "2361": [81, 82], "23623": 81, "2363": 82, "2364": 83, "2366": 85, "23663": 81, "2367": 86, "23689": 81, "23691": 81, "237": [82, 85, 86], "23706": 81, "2371": [82, 86], "2372": 85, "2374": [83, 86], "23748": 86, "2376": 83, "2377": 82, "2378": 86, "23781811553089": 3, "23793153": 95, "238": [76, 81, 82, 86], "2380": 86, "23809": 81, "2381": [82, 86], "2382": 81, "23820": 81, "2383": 81, "23841": 81, "2385": 81, "23864": 81, "2387": [85, 88], "23872": 81, "23873": 81, "23877": 86, "2388": 82, "23881": 81, "23884": 81, "23887": 86, "2389": 81, "23895": 83, "239": [76, 82, 84, 85, 86, 95], "2390": 81, "2392": 81, "2395": 86, "23965": 81, "2398": 83, "23983": 81, "23985": 86, "24": [73, 76, 77, 78, 81, 82, 83, 84, 85, 86, 95], "240": [76, 82, 86], "24000": 81, "24005": 81, "24016": 81, "24019": 81, "24022": 81, "2403": 86, "24032": 73, "2404": [], "240463": 85, "24069": 85, "2407": [], "2408": 86, "2409": 83, "241": [78, 81, 82, 84, 86], "2411": 86, "2412": [83, 86], "24126": 81, "2416": 82, "242": [73, 79, 82, 84, 85, 86, 95], "2420": 86, "24206": 81, "24217": 81, "2424": 82, "2425": 82, "24255": 83, "2426": 86, "24269": 81, "2427": 86, "24276": 81, "24289": 81, "2429": 86, "24297": 82, "243": [82, 84, 86], "2430": 86, "24303": 81, "24305": 81, "24326": 81, "24331": [81, 85], "24338": [86, 87], "2434": 86, "24341": 86, "2435": 86, "2436": 86, "24376": 81, "24379": 81, "2438": 82, "24389": 81, "2439": [82, 86], "24397": 81, "244": [78, 82, 84, 86], "24425": 81, "2443": 86, "2445": 86, "24455": 86, "2447": 81, "245": [0, 82, 85, 86], "24507": 81, "24507780": 95, "24510": 81, "2452": 86, "2453": 83, "24538": 81, "24540": 81, "24541": 83, "24546": 81, "24552": 81, "2456": [74, 82, 86], "2457": 86, "24576": 86, "2458": 86, "24586": 81, "2459": 86, "24597": 81, "246": [73, 76, 82, 83, 86], "2460": 86, "24607": 81, "2461": 86, "24614": 81, "2462": 86, "24623": 81, "24629": 81, "2463": [3, 82, 86], "24631": 81, "24633409": 95, "2464": 86, "24652": 81, "2466": 81, "2467": 86, "2468": 86, "246904": 84, "247": [81, 82, 84, 86], "24706": 81, "24712": 86, "2472": 86, "2473": 82, "2474": 82, "24742": 81, "24748": 81, "2475": [75, 85], "24755": 81, "24757": 81, "247651": 76, "24780": 81, "2479": 86, "24795": 81, "248": [73, 82, 84, 86], "2480": 85, "2481": [85, 86], "24812": 81, "24816": 85, "2482": 86, "24826": 81, "2483": [82, 86], "24848": 85, "2485": [], "24860": 81, "24863": 81, "2488": 81, "24889": 81, "249": [73, 82, 84, 86], "2490": 85, "24901": 81, "2491": 86, "24914152": 95, "24914169": 95, "2492": 86, "24929": 81, "2493": 82, "2494": [82, 85], "24972": 81, "24978": 81, "2498": 86, "24988": 81, "2499": [82, 83], "24999": 81, "25": [1, 11, 43, 47, 53, 63, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86], "250": [47, 54, 63, 69, 72, 76, 81, 82, 84, 86, 95], "2500": 86, "25006873": 95, "25013": 83, "25018": 81, "25023": 81, "25027": 85, "2503": [82, 86], "25031": 81, "2504": 86, "25045": 86, "25051": 81, "25058": 81, "25059": 81, "25067": 81, "2507": 86, "2508": 86, "25082": 86, "251": [73, 82, 84, 86, 88], "2510": 83, "25119": 81, "2512": [82, 85], "2513": 82, "25135": 81, "25136092": 95, "25139": 83, "25140": 81, "251517": 85, "2516": 86, "2517": 86, "25187": 81, "2519": 86, "25192": 86, "25193": 81, "25198": 81, "252": [76, 81, 82, 84, 86], "25214": 81, "25226": 81, "25232": 85, "25238": 81, "2524": 86, "25242914": 95, "2525": 86, "2526": 83, "2527": [3, 82, 86], "25285": 81, "25286849": 95, "2529": 86, "253": [73, 82, 84, 86], "2530": 86, "2531": 81, "25318": 81, "2532": 82, "25323": 81, "2533": [84, 86], "25355": 84, "25357": 81, "2536": 82, "25362050": 95, "2539": 86, "254": [76, 78, 81, 82, 86], "2540": [85, 86], "2541": [], "25415": 79, "2543": 86, "25438": 81, "25442": 81, "25453": 81, "25453071": 95, "2546": 86, "25461": 81, "25466": 84, "25474": 81, "25478847": 95, "25479": 81, "2548": 86, "25484844": 95, "255": [40, 73, 75, 82, 84, 86], "25506": 81, "2551": 86, "25511": 81, "2552": 86, "255222": 86, "2554": 86, "25547": 81, "2555": 83, "25565": 81, "2557": 82, "25577": 81, "2558": 86, "255800": 76, "25585": 81, "2559": 86, "25596": 81, "256": [53, 73, 75, 78, 82, 86, 87], "2560": 86, "25616": 86, "2562": 86, "2564": [78, 86], "2565": 82, "25657": 81, "25661": 81, "25664746": 95, "25664747": 95, "2567": 86, "25673": 81, "25676": 81, "25686": 83, "2569": 86, "25694": 81, "25696": 81, "25697": 86, "256\u00b3": [82, 86, 87], "257": [73, 78, 79, 82, 86], "2570": 86, "2571": 86, "25710": 81, "25717": 81, "25720": 81, "25723925": 95, "2573": 86, "25735": 81, "2574": 86, "25741": 81, "25744": 81, "2575": 86, "25751308": 95, "2576": 82, "25765": 81, "25766": 81, "2577": 86, "2578": 74, "25781": 81, "25781634": 95, "25787": 81, "258": [76, 81, 82, 86], "2583": 86, "25844": 81, "25846": 81, "2585": 82, "2588": 81, "259": [73, 78, 81, 82, 84, 86], "2590": 86, "25901": 81, "2591": 86, "25925": 81, "2593": 86, "25938": 81, "2594": [82, 86], "259466": 82, "2596": 83, "25965": 81, "2597": 82, "2598": 86, "25988": 81, "26": [73, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 95, 96], "260": [73, 75, 81, 82, 86], "26008": 81, "2602": 86, "26023": 81, "2604": 82, "2605": 86, "26057680": 95, "2606": 86, "26069": 81, "2608": 81, "2609": 81, "261": [73, 78, 82, 86, 95], "2611": 81, "26118": 81, "26121": 83, "2613": [82, 86], "26130": 86, "26136": 84, "2615": 86, "2616": 86, "26167": 84, "26174": 84, "2618": 86, "2619": 86, "26191": 81, "262": [73, 75, 82, 83, 84, 86], "2620": [83, 86], "2621": [85, 86], "26211": 86, "26215": 81, "2622": 86, "2623": 82, "26244": 81, "2625": 85, "26252": 84, "2626": 86, "26279": 86, "26280336": 95, "26289": 81, "263": [49, 73, 76, 82, 84, 85, 86], "26302": 86, "2631": 86, "2632": [82, 86], "2633": 86, "26334": 81, "2634": 86, "26341": 81, "26352473": 95, "2637": 86, "2638": 86, "2639": 85, "264": [73, 82, 84, 86], "2640": 86, "26413": 85, "2642": 86, "2643": 81, "2646": 86, "2647": 86, "26476": 81, "2648": 86, "26482": 81, "2649": 82, "26494": 81, "265": [73, 78, 81, 82, 86], "2650": 86, "26503": [86, 87], "26504": 81, "2652": [11, 95], "2654": 86, "26549": 81, "26569": 81, "2657": 86, "26575": 81, "2658": 82, "266": [73, 78, 82, 84, 86], "2660": 86, "26616": 81, "2662": 86, "2664": 86, "26646": 81, "26659": 81, "2666": [11, 81], "26661": 81, "2667": 86, "26682": 81, "267": [73, 81, 82, 85, 86], "2670": 86, "2671": [81, 86], "2673": 86, "2675": [], "267504": 74, "26755": 83, "2676": 86, "2677": 86, "26774": 81, "2679": 82, "268": [73, 78, 81, 82, 86], "2680": 86, "2681": 86, "2682": [], "2683": 86, "2684": 85, "2685": 86, "2686": 81, "26874": 82, "2688": 86, "26887": 81, "2689": 82, "26897": 86, "26898": 81, "269": [81, 82, 84, 86], "2691": [81, 82, 86], "26933": 81, "26934": 83, "2697": 86, "27": [73, 75, 77, 78, 81, 82, 83, 84, 85, 86], "270": [82, 86], "2700": 86, "2701": 86, "2703": 86, "2705": [74, 86], "27050135": 95, "2706": 82, "2708": [83, 86], "27085": 81, "271": [81, 82, 84, 86], "2710": 86, "2711": 83, "27121": 81, "27127": 81, "27143": 81, "2715": 86, "2716": 86, "27169": 81, "27181": 81, "2719": 86, "27191": 83, "272": [73, 76, 78, 82, 86], "2722": 86, "2723": [76, 86], "2724": 81, "27266": 81, "2727": 83, "27272": 81, "2728": [81, 82], "2729": 78, "273": [82, 84, 86], "2730": 86, "27324": 86, "2733": 86, "27368": 81, "274": [73, 81, 82, 86], "27402": 81, "2744": 86, "27443": 83, "27452": 83, "27486": 81, "27493": 81, "275": [76, 82, 84, 86], "27504": 85, "2751": [81, 86], "27533": 83, "2757": 81, "27575": 81, "2758": [81, 86], "2759": 86, "276": [73, 82, 84, 86], "2763": [81, 86], "2766": 86, "27665": 81, "2767": 82, "2768": [85, 86], "277": [73, 82, 84, 86], "2772": [81, 84], "2773": 82, "27743": 81, "278": [76, 81, 82, 84, 85, 86], "27804": [81, 85], "2782": 86, "2783": 82, "27842": 83, "27855": 83, "27862": 83, "27863": 86, "2788": 86, "279": [82, 86], "2790": 86, "2791": 86, "2792": 78, "2793": 86, "27939": 81, "2795": 86, "2796": [82, 86], "27977": 81, "2798": 81, "27980508": 95, "2799": [74, 82], "27_dial": 76, "27_refined_cel": 76, "28": [11, 73, 78, 81, 82, 83, 84, 85, 86, 87, 95], "280": [82, 86, 87], "2800": 86, "2801": 86, "2802": 86, "2803": 86, "2806": 81, "2807": 86, "281": [81, 82, 86], "2810": 83, "2811": 86, "2812": 86, "2814": 86, "2815": 86, "2816": 86, "2817": 86, "2818": 86, "2819": 86, "28197": 86, "282": [18, 69, 73, 82, 86], "28205": 81, "28219": 86, "2822": 85, "2824": 81, "28243": 83, "2825": 86, "28257": 85, "2826": 81, "2827": 86, "2828": 86, "2829": 81, "28293": 83, "283": [78, 82, 84, 86], "28303": 86, "28308": 81, "283277": 87, "2834": 86, "2835": 81, "2839": 86, "284": [82, 86], "28409": 81, "2842": 82, "2843": 86, "2845": 86, "28466": 81, "285": [73, 82, 84, 86], "2851": 78, "28525": 81, "28538": 83, "2856": 83, "28579": 86, "28586": 81, "2859": 86, "286": [73, 81, 82, 84, 85, 86], "28605": 82, "2863": [84, 86], "2865": [84, 86], "2869": [83, 86], "28695": 81, "287": [73, 82, 84, 86], "2871": 86, "2873": 81, "2874": 86, "2875": 86, "2876": 78, "28764": 86, "28766": 81, "2877": 86, "28776": 86, "2878": [82, 85], "28785": 83, "2879": 86, "288": [73, 82, 84, 86], "2880": [], "2881": 86, "2882": [85, 86], "2883": 86, "2884": 86, "28874": 81, "2888": 86, "289": [73, 82, 84, 86], "2890": 86, "28915": 81, "2892": 84, "28935": 74, "2894": 86, "2895": 86, "2896": 86, "28981": 83, "28989718": 95, "28_dial": 76, "28_scale": 76, "28_scaled_unmerg": 76, "28e": 84, "29": [73, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 87, 96], "290": [73, 82, 86], "29002": 81, "29009": 81, "29034": 84, "29035": 84, "2904": [78, 86], "29046": 84, "2905": 86, "29054": 84, "2907": 86, "29087": 81, "291": [73, 74, 82, 86], "2911": 86, "29114": 85, "2912": 83, "2916": [73, 81], "292": [18, 69, 73, 76, 81, 82, 84, 86], "2920": 84, "2922": 86, "2923": [82, 86], "2924": 78, "2928": 83, "293": [82, 86], "29306": 81, "29307": 83, "29309": 81, "2931": 86, "2933": 81, "2934": 86, "2935": [], "2936": 82, "2937": [73, 82], "2938": [82, 86], "2939": 86, "294": [73, 81, 82, 86], "2940": 86, "29400": 73, "2945": 86, "2946": 86, "2949": 86, "2949728": 78, "295": [73, 82, 86], "2950": 86, "2951": 85, "2952": [81, 86], "2953": 86, "29533234": 95, "29543": 81, "29556": 81, "295803077552249": 3, "29589": 81, "2959": 82, "29594": 86, "296": [73, 82, 84, 86], "2961": 86, "2962": 86, "29632": 83, "2964": 86, "2965": 86, "2966": 86, "29662": 83, "29667": 83, "29673": 81, "29676": 85, "29682": 81, "29697": 81, "297": [81, 82, 83, 84, 86], "29717711": 95, "2972": 86, "2973": 86, "2976": 81, "29764": 83, "2978": 83, "2979": [82, 86], "298": [81, 82, 86], "2981": 86, "2982": 86, "2984": 86, "2985": 83, "29869": 81, "2987": 86, "29872002": [75, 95], "2988": 86, "29881": 81, "299": [73, 82, 83, 84, 86], "29905": 81, "2992": 78, "2993": 82, "29952": 83, "2996": 78, "29_dial": 76, "29m36": 83, "2_1": [75, 77, 84], "2_integr": 63, "2d": [1, 2, 12, 14, 47, 54, 63, 98], "2f": 44, "2ul": [10, 12, 26], "2\u03b8": [47, 51, 70, 72], "3": [0, 1, 2, 3, 6, 11, 15, 18, 22, 33, 35, 37, 39, 40, 41, 43, 45, 47, 48, 50, 51, 52, 53, 54, 57, 58, 59, 60, 61, 62, 63, 68, 72, 73, 74, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96, 99], "30": [11, 45, 53, 66, 73, 74, 75, 81, 82, 83, 84, 85, 86, 87, 97], "300": [53, 59, 60, 75, 76, 82, 83, 84, 86], "3000": 86, "30000": 82, "30046": 81, "3005": [78, 86], "30057": 81, "3007": 82, "30075": 81, "300879": 76, "301": [82, 84, 86], "3010": 86, "3011": 86, "3012": 86, "301260": 84, "3013": 86, "3014": 86, "301412": 76, "3016": 86, "3018": 86, "3019": 86, "30198898": 95, "302": [73, 82, 86], "3021": 86, "30225": 83, "3023": 86, "3024": 86, "30251": 81, "30274": 81, "3028": 86, "3029": 81, "303": [81, 82, 86], "3033": 86, "30346": 81, "3035": [81, 86], "30358": 83, "3037": 86, "30376": 82, "30387": 83, "304": [73, 82, 84, 86], "3042": 86, "3045": 82, "30452": 86, "3047": 86, "3048": 86, "304888": 76, "305": [75, 82, 86], "3052": 86, "3053": 86, "30539": 81, "30551": 81, "3056": [81, 86], "3057": 86, "3057089": 78, "306": [73, 82, 84, 86], "3061": 86, "3063": 86, "30649": 83, "307": [73, 81, 82, 86], "3072": 86, "3073": 78, "3075": 86, "3076": 81, "3079": [81, 86], "308": [82, 86, 87], "3080": 86, "3082": [82, 85], "3084": 86, "30869": 81, "3087": 86, "3088": 86, "309": [75, 82, 86, 95], "3091": [82, 86], "3095": 86, "30950396": 95, "3097": [78, 86], "30996": 81, "31": [11, 35, 73, 74, 76, 81, 82, 83, 84, 85, 86, 95], "310": [73, 82, 86], "3100": 86, "31004": 81, "3101": 86, "3103": 86, "3104": 86, "3106": 86, "3107": 86, "31088": 81, "3109": 86, "311": [82, 86], "3112": 86, "3115": 86, "3119": 86, "312": [73, 82, 86], "312213": [], "312214": 86, "3123": 86, "31232": 81, "3124": [], "3126": 86, "31271": 81, "3128": 86, "313": [82, 84, 85, 86], "3132": 86, "31331": 81, "3135": [78, 86], "3137": 86, "3139": 78, "313906": [], "313907": 86, "314": [73, 82, 84, 86], "3140": 86, "3142": [84, 86], "3143": 86, "3144": 84, "3147": 78, "3148": 86, "315": [73, 76, 82, 86], "3151": 78, "3152": 86, "31531": 84, "31547": 84, "3156": 78, "3157": 86, "31578": 83, "3159": 86, "31598": 84, "316": [76, 82, 85, 86], "31601": 81, "31614": 81, "3162": 86, "3163": 86, "3164": 86, "3167": 86, "317": [74, 82, 84, 86], "3171": 86, "31716": 81, "31728": 81, "31729": 81, "317393": 81, "3174": 86, "317541": 81, "3176": 83, "3177": [85, 86], "318": [73, 82, 84, 86], "3180": 86, "3181": 83, "3182": 86, "3183": [], "3184": 86, "3186": [], "3187": 86, "3188": 86, "31898": 83, "319": [76, 82, 86], "3190": 86, "3191": 86, "31911": 81, "3192": 86, "3193": 86, "3194": 86, "31962": 81, "3199": 86, "31e": 84, "32": [73, 75, 76, 81, 82, 83, 84, 85, 86, 96], "320": [82, 86], "3200": 82, "32007": 81, "3202": 86, "32036": 81, "3204": 86, "3205385": 78, "3207": [85, 86], "3208": 86, "3209": 81, "32094": 81, "321": [76, 82, 84, 86], "3210": 86, "3211": 86, "32129": 81, "321472": 79, "3215": 86, "3216": [81, 86], "3218": 86, "3219": [], "321968": 76, "322": [73, 76, 82, 84, 86], "3220": 86, "3221": 86, "3225": 82, "32254063": 95, "3226": [85, 86], "32288": 83, "3229": [82, 85], "323": [73, 82, 84, 86], "3230": [82, 86], "3232": [78, 86], "3233": [78, 86], "3234": 86, "3237": 82, "3238": 81, "3239": 86, "324": [73, 81, 82, 84, 86], "3240": [83, 86], "3241": [40, 84, 86], "3242": 86, "3246": 85, "324979": [], "324980": 86, "325": [82, 84, 86], "325072": [], "325073": 86, "325074": 86, "325189": [], "325190": 86, "3253": 86, "325378": [], "325379": 86, "325380": 86, "325383": [], "325384": 86, "32568": 81, "3258": 86, "326": [73, 82, 86], "3262": 86, "32623": 83, "3264": 86, "32645": 81, "3265": 86, "32658": 85, "3266": 86, "3267": 86, "327": [73, 78, 81, 82, 84, 86], "327038": [], "327039": 86, "327076": [], "327077": 86, "3272": 86, "3273": 86, "3274": 86, "3276": [81, 86], "3277": 86, "328": [73, 74, 79, 82, 86], "3280": 86, "3281": 81, "3285": 81, "3286": 86, "32879": 81, "3288791": 78, "3289": [78, 85], "329": [82, 84, 86], "329174": 82, "3293": 86, "3295": 86, "3296": 86, "3297": 85, "3297608": 78, "3298": 86, "3299": 95, "33": [73, 75, 76, 77, 81, 82, 83, 84, 85, 86, 96], "330": [82, 86], "3302": 86, "33030237": 73, "3304": 86, "3309": 86, "331": [73, 76, 78, 81, 82, 85, 86], "3311": [83, 86], "33153": 81, "3316": [], "3317": 86, "331750": 81, "3319": 82, "331984": 81, "332": [73, 82, 86], "3321": [82, 86], "3323": 86, "3324": 86, "3326": [], "3327": 86, "333": [73, 81, 82, 86], "3330": 86, "33333": 14, "33371": 81, "33398": 81, "334": [73, 82, 86], "33404": 81, "3342": 83, "33424": 81, "3343": 86, "3345": 86, "3346": [83, 86], "3347": 86, "3348": 86, "3349": 86, "335": [74, 76, 82, 84, 86], "33539": 82, "33544": 81, "3358": 86, "3358310": 78, "3359": 86, "33596": 85, "336": [74, 82, 86], "3361": 86, "3362": 88, "3364": 86, "3369": 85, "337": [82, 86], "3375": 85, "338": [45, 46, 47, 50, 51, 76, 82, 86], "33809": 83, "3383": 86, "33843": 81, "338446": 81, "338516": 77, "3386": 86, "338720": 81, "338728": 77, "33883": 85, "33884": 85, "3389": 86, "339": [78, 79, 82, 86], "3394": 86, "33972532": 74, "34": [73, 76, 78, 81, 82, 83, 84, 85, 86], "340": [73, 81, 82, 86, 95], "3400": 85, "3402": 86, "3403": [82, 86], "3407": 86, "3408": [82, 86], "341": [82, 84, 86], "34173": 82, "342": [82, 84, 86], "3420": 86, "34229": 73, "3423": 86, "34241": 81, "3428": 86, "3429": [], "343": [81, 82, 85, 86], "3430": 86, "34304": 81, "3431": 86, "34327213": 73, "3435": 86, "3439": 86, "344": [82, 86], "3440": [], "34444": 83, "3446": 86, "34464": 83, "3449": 86, "345": [54, 73, 75, 82, 85, 86], "3450": 86, "34512": 81, "3455": 82, "34551": 85, "346": [40, 73, 76, 82, 84, 86], "34611": 81, "3463": 86, "3464": 86, "3465": 86, "3466356": 78, "34664": 81, "3467": 86, "347": [73, 82, 86], "3472": 86, "34747533": 95, "3477": 86, "3479": 86, "348": [82, 86], "3480": 86, "3484342": 78, "3489": 81, "349": [82, 84, 86], "3490": [81, 86], "34911": 83, "3493": 86, "3495": 86, "3496": 86, "3499": 83, "35": [0, 2, 3, 73, 74, 77, 81, 82, 83, 84, 85, 86], "350": [73, 82, 86], "35019": 81, "3502": 86, "3503": 82, "3508": 83, "3509": 86, "351": [82, 86], "3510": 35, "3512": 86, "3514": [], "35145": 81, "3515": 86, "352": [49, 73, 82, 86, 95], "35204": 83, "35249": 81, "3525": [75, 86], "3526": 86, "353": [73, 78, 82, 86], "35304": 83, "3532": 86, "35339": 81, "3534": 86, "3535": 86, "3537": 86, "3539": 86, "35395": 83, "354": [82, 86], "35422": 85, "3546": 86, "3548": 86, "35488": 81, "3549": 86, "35492": 85, "355": [82, 86], "3551": 86, "3554": 86, "3555": [83, 86], "3558": 81, "35593": 85, "356": [79, 82, 86], "3560": 81, "3561": 81, "3564": [82, 86], "35647922": 95, "3565": [81, 82], "357": [82, 86, 95], "3572": 86, "3577": 86, "3578": 86, "35789": 81, "358": [75, 82, 86], "3580": 86, "3581": 81, "3582": 86, "3586": 86, "3588": 86, "359": [73, 76, 82, 83, 86], "35943": 83, "3599": 86, "35999": 86, "36": [40, 53, 59, 60, 73, 76, 81, 82, 83, 84, 85, 86], "360": [40, 81, 82, 84, 86, 87], "36000": [86, 87], "3601": 86, "3602": 86, "3603": 84, "3609": 86, "361": [73, 82, 86], "36137": 83, "3618": 86, "3619": 86, "362": [82, 84, 86, 87], "3620": 86, "3622": 86, "3623": 86, "3624346": 78, "36268": 81, "3628": [84, 86], "3629": [82, 86], "363": [73, 82, 84, 86], "3630": 86, "3631": 84, "3632": 86, "3635": [84, 86], "36377": 81, "36386": 83, "364": [73, 81, 82, 86], "3641": 86, "3644": 86, "36458": 81, "3646": 86, "3647": 86, "3648": 86, "36483": 81, "365": [73, 76, 82, 84, 86], "3655": 86, "36559": 81, "3657": [], "3658": 86, "3659": 86, "365e": 86, "366": [73, 76, 81, 82, 86], "3660": 86, "366022": 86, "36619": 81, "3662": 86, "36662": 74, "3669": 86, "367": [82, 86], "36708": 81, "36731": 81, "3674": 86, "3674101744536096": 76, "3676": 86, "36776": 81, "3678": 86, "36795": 81, "368": [82, 84, 86], "3680": 86, "3681": 86, "3683": [81, 86], "36858": 81, "368590": 86, "368699": 86, "36893": 81, "369": [82, 85, 86, 95], "3692": 86, "3693": 86, "36983": 81, "3699": 82, "37": [11, 53, 64, 73, 74, 76, 77, 81, 82, 83, 84, 85, 86], "370": [76, 81, 82, 86], "37002": 81, "3701": 86, "3707": 86, "37074": 83, "371": [73, 76, 82, 85, 86], "3711": 86, "37139": 83, "3714": 86, "3717": 86, "3718": 78, "372": [82, 85, 86], "3723": 74, "3725": 81, "373": [82, 86], "37309": 81, "3730940": 82, "3731": 86, "3732": 86, "3734": 82, "37366": 81, "3737": [81, 86], "37377": 81, "374": [73, 82, 86], "37408": 81, "3742": 86, "37466": 85, "3748": 86, "375": [73, 82, 86, 87], "3750": 86, "37528": 81, "37577": 81, "37586": 83, "376": [82, 86], "3760": 86, "3765": 83, "3767": 86, "377": [82, 86], "3771": 86, "3773": 82, "3774": 82, "3776": [81, 86], "3777": 86, "378": [82, 83, 86], "37822": 81, "37838": 81, "37843": 81, "3785": 86, "3788": 82, "379": [73, 82, 86], "3790": 86, "38": [3, 40, 73, 76, 78, 81, 82, 83, 84, 85, 86, 96], "380": [82, 86], "3800": 81, "3803": 81, "3805": 86, "381": [82, 84, 86], "3810": 85, "3813": 85, "3815": 86, "38155": 81, "3817": 86, "3819": 86, "382": [82, 86], "3826": 86, "383": [82, 84, 86], "38322": 81, "3833": 86, "3835": [81, 86], "38365": 81, "3837": 86, "38373": 81, "384": [82, 85, 86], "385": [82, 84, 86, 95], "38505": 81, "38555": 81, "38596": 83, "386": [73, 82, 86], "38606": 83, "3862": [], "3863": 86, "3864": 82, "3867": 86, "3868": 86, "3869": 86, "387": [82, 86], "3870": 86, "3877": 86, "388": [82, 86], "3881": 86, "3883": 86, "38874": 81, "38875": 81, "3888": 82, "3889": 86, "38894": 81, "38899": 81, "389": [73, 76, 82, 86], "3894": 82, "38962": 81, "3898": 82, "3899": [82, 86], "39": [73, 77, 78, 81, 82, 83, 84, 85, 86, 96], "390": [82, 83, 84, 86], "3905": 86, "39065": 81, "3908": 81, "3909": 81, "391": [82, 86, 87], "3916": 82, "392": [82, 83, 86], "39219": 81, "39228": 81, "3923": 86, "39245": 83, "39246": 81, "3926": 86, "3927": 86, "3929": 86, "39294": 83, "393": [73, 82, 86], "39314": 81, "3933": 82, "3935": 81, "3939": 82, "394": [73, 81, 82, 85, 86], "3944": 82, "39465": 81, "39499": 81, "395": [82, 86], "3954": 86, "396": [82, 86], "3961": 86, "39675": 81, "3968": 82, "39692": 81, "397": [73, 82, 86], "39711": 81, "3973": 86, "39733": 86, "398": [82, 86], "39851": 81, "399": [11, 64, 76, 82, 83, 84, 85, 86, 95], "39922": 83, "3d": [1, 11, 12, 47, 52, 53, 63, 74, 82, 83, 86, 87, 96, 98], "3ded": [74, 80], "3deg": [40, 84], "3e": 88, "3rd": 97, "4": [0, 1, 2, 3, 11, 16, 18, 22, 33, 35, 40, 43, 44, 45, 46, 47, 48, 50, 51, 53, 54, 60, 63, 64, 69, 70, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 97], "40": [62, 73, 74, 76, 81, 82, 83, 84, 85, 86, 87, 96], "400": [76, 81, 82, 85, 86], "400223": 76, "40028": 81, "40052": 81, "4006": 82, "401": [82, 83, 84, 86], "40106": 81, "4011": 82, "40123": 83, "40137": 81, "4014": 82, "40149": 81, "4015": 82, "40151": 81, "4018": [82, 86], "40185": 81, "40191": 81, "402": [82, 86], "4020": 0, "4021": 86, "4022": [], "4023": 82, "4029": 81, "40298": 83, "403": [74, 82, 83, 84, 86], "4034": 82, "40342": 81, "40359": 82, "4038": 81, "404": [82, 86], "4043": 82, "4047": 86, "4049": 81, "405": [18, 40, 81, 82, 83, 84, 86, 95], "4052": 86, "40525": 81, "4053": [], "40577": 81, "4059": 85, "406": [81, 82, 86], "4060": 86, "4061": 86, "4063": 86, "40658": 81, "407": [11, 82, 86], "4071": 86, "40725": 81, "4073": 86, "4074": 86, "4075": 82, "4076": [82, 86], "4077": [82, 84], "4078": 82, "4079": 86, "408": [73, 82, 86], "40816": 81, "40848": 81, "40867": 81, "4087": 86, "409": [11, 64, 73, 81, 82, 84, 85, 86], "4094": 86, "40955": 81, "41": [0, 73, 75, 78, 79, 81, 82, 83, 84, 86, 88], "410": [18, 40, 82, 84, 86, 95], "4100": 86, "4101": 86, "4102": 82, "41024": 81, "4103": 81, "41055": 81, "411": [81, 82, 86], "4111": [81, 82], "4112": 82, "41136": 87, "4114": 82, "41145": 81, "41177": 81, "412": [82, 85, 86], "4121": 82, "4122": 81, "4128": 81, "413": [11, 73, 82, 86], "4130": 82, "41311": 81, "414": [82, 86], "4141": 82, "41469": 83, "4147": 82, "4148": 82, "415": [82, 84, 86], "4152": 82, "41568": 83, "41585": 81, "415898": 76, "416": [82, 86], "4161": 82, "41622": 86, "41623": [], "4165": 86, "41673": 81, "417": [81, 82, 85, 86], "41713": 81, "4172": 82, "418": [82, 84, 86], "41832": 85, "419": [73, 74, 82, 86], "41c": 84, "42": [4, 53, 59, 60, 64, 72, 76, 78, 81, 82, 83, 84, 85, 86, 87, 96], "420": [82, 84, 86], "42044": 81, "42048": 76, "421": [73, 76, 82, 84, 85, 86], "4212": 88, "42183": 88, "422": [73, 76, 82, 84, 86], "4229": 79, "423": [73, 82, 86], "424": [73, 82, 86], "4242": 4, "4243": 82, "42443": 82, "42447": 81, "4247": 81, "42478": 83, "4249": 81, "425": [81, 82, 85, 86], "4256": 82, "4257": 84, "42575": 81, "426": [73, 82, 86], "4263": [85, 86], "4265": 81, "4266": 86, "42663": 81, "42672": 81, "427": [73, 82, 86], "42778": 81, "428": [73, 82, 86], "42802": 81, "42803": 81, "42881": 81, "42882": 86, "4289": 86, "429": [73, 74, 81, 82, 86], "4291": 86, "42c": 84, "43": [73, 78, 79, 81, 82, 83, 84, 85, 86], "430": [82, 86], "43068": 81, "431": [82, 86], "4310": [81, 86], "43153": 81, "432": [73, 82, 86], "43205": 81, "4328": [74, 86], "433": [82, 86], "43312": 81, "4333": 84, "4335": 82, "43388": 81, "434": [82, 86], "4340": [84, 86], "43408": 81, "4341": 82, "4345": 78, "43483": 81, "435": [74, 82, 86], "4352": 83, "43547": 81, "436": [73, 82, 86], "43612": 82, "43642": 82, "43661": 82, "4368": 86, "4369": 86, "437": [78, 82, 86], "4371": 95, "43778": 82, "4378": 81, "4379": [81, 86], "438": [75, 82, 86], "439": [73, 76, 82, 86], "44": [48, 78, 81, 82, 83, 84, 85, 86], "440": [82, 86], "44019": 81, "4407": 82, "44084": 81, "4409": 82, "441": [82, 84, 85, 86], "44117": 81, "442": [73, 82, 86], "44268": 81, "443": [82, 86], "44329": 82, "44341": 82, "444": [2, 76, 82, 83, 86], "4441": 86, "445": [82, 85, 86], "4450": 86, "44533": 81, "44535": 82, "446": [82, 86], "44653": 81, "447": [81, 82, 84, 86], "44711": 81, "44719": 81, "44757": 81, "4479": 82, "448": [76, 82, 86], "4483": 82, "449": [82, 86], "44911": 81, "4492": 86, "44932": 81, "44994": 81, "45": [11, 53, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 88], "450": [82, 86], "45054": 81, "4508": 74, "451": [82, 86], "4516": 86, "452": [73, 74, 82, 86], "4526": [], "453": [82, 86], "45303890619488": 3, "45355": 81, "454": [74, 82, 86], "455": [73, 74, 82, 85, 86], "45501": 81, "45551": 82, "4556": 82, "45564": 81, "456": [82, 86], "45694": 85, "457": [2, 81, 82, 84, 86], "4574": 82, "458": [2, 81, 82, 86], "459": [73, 82, 86], "4594": 84, "45e": [], "46": [49, 73, 76, 79, 81, 82, 83, 84, 85, 86], "460": [74, 82, 85, 86], "4603": 84, "46071": 81, "461": [76, 82, 86], "46152": 85, "46181": 81, "462": [82, 86], "46232": 81, "46252": 81, "46257": 83, "46291": 83, "463": [76, 82, 86], "46301": 81, "46307e": 86, "46332": 85, "46360": 84, "46365": 81, "464": [2, 82, 86], "4641": 82, "465": [82, 86], "466": [82, 86], "466492": 85, "46698": 81, "467": [81, 82, 86], "4673": 84, "4675": [84, 86], "468": [82, 86], "46806": 82, "46855": 83, "469": [82, 86], "46902": 83, "46907": 81, "46951": 83, "4698317405529955": 3, "47": [40, 74, 75, 81, 82, 83, 84, 85, 86, 95], "470": [82, 86], "4701": 81, "4706": 84, "4707": [81, 84], "47078": 81, "471": [73, 82, 84, 86], "47124": 81, "4718": 73, "472": [73, 81, 82, 86], "472000": 85, "47213": 83, "47216": 81, "47248": 81, "4727": 82, "4729": [79, 86], "473": [82, 86], "47301": 82, "47338": 81, "47367": 82, "474": [82, 84, 86], "47418": 82, "4747": 81, "475": [73, 82, 86], "47572": 81, "4759": 84, "476": [81, 82, 86], "47641": 82, "47678": 83, "477": [73, 82, 86], "47756": 82, "4777": 82, "47797": 81, "478": [81, 82, 86], "47841": 81, "47859": 82, "479": [82, 86], "4791": 82, "48": [73, 76, 77, 78, 81, 82, 83, 84, 85, 86, 95], "480": [81, 82, 86], "4801": 84, "48028": 81, "48053": 83, "48077": 81, "48078": 81, "48084": 81, "481": [73, 82, 84, 86], "4812": 82, "48132": 81, "48186": 81, "4819": 83, "482": [76, 82, 86], "4822": 86, "483": [73, 82, 86], "4831": 84, "4836": 81, "4838": [81, 82], "484": [82, 86], "4849": 74, "485": [75, 78, 82, 86], "48533": 86, "4856": 73, "48569": 81, "486": [73, 82, 86, 95], "48625": 83, "48667": 81, "487": [81, 82, 84, 85, 86], "487536": 85, "48772": 82, "488": [82, 86], "48806": 85, "4886": 86, "4889": 73, "489": [82, 84, 86], "48906": 81, "48975": 82, "49": [73, 81, 82, 83, 84, 85, 86, 88, 95], "490": [73, 76, 82, 86], "491": [73, 82, 86, 95], "49115": 81, "49118": 86, "4917": [74, 81], "49195": 82, "492": [73, 81, 82, 86], "49246": 86, "4927": 82, "493": [73, 82, 86], "49387": 83, "494": [81, 82, 83, 85, 86], "4940": 82, "4945": 81, "4949": 82, "495": [73, 82, 84, 86], "495976": 3, "496": [81, 82, 84, 86], "49664": 82, "497": [82, 86], "498": [45, 46, 47, 50, 51, 82, 85, 86], "49883": 82, "498876": 85, "499": [82, 85, 86], "49935": 82, "49941": 82, "499425": 85, "49961": 82, "4_1": 84, "4a": 99, "4b": 99, "5": [0, 1, 2, 3, 6, 11, 21, 33, 40, 41, 44, 45, 46, 47, 48, 50, 51, 53, 54, 58, 59, 60, 63, 66, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 97, 99], "50": [1, 16, 40, 41, 43, 50, 51, 53, 54, 55, 58, 72, 73, 78, 81, 82, 83, 84, 85, 86], "500": [53, 59, 60, 73, 75, 82, 86], "5000": [40, 72, 73], "50000": [63, 73], "500054": 85, "50058": 81, "501": [82, 84, 86], "50131": 83, "50161": 83, "502": [82, 83, 84, 86], "50240": 86, "50245": 86, "50270": 86, "503": [73, 79, 82, 84, 86], "504": [75, 82, 84, 86], "50436": 81, "5046": 85, "505": [73, 82, 84, 86], "5056": 86, "50568": 81, "506": [73, 75, 82, 84, 86, 95], "50628": 82, "50635": 81, "5064": 83, "50654": 81, "50699": 83, "507": [73, 82, 84, 86], "50746": 81, "5079": [82, 86], "508": [76, 82, 84, 85, 86], "50846": 83, "509": [82, 86], "50948": 78, "51": [0, 73, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86], "510": [82, 86], "5100": 81, "51078": 83, "511": [82, 86], "51129": 81, "5117": 86, "512": [82, 86], "5123": 81, "51263": 81, "513": [73, 82, 86], "51306": 81, "51318": 82, "514": [73, 75, 82, 86], "51405": 88, "5144": 81, "51458": 82, "5147": 85, "515": [75, 82, 86], "51574": 81, "516": [82, 86], "51628": 83, "517": [82, 85, 86], "51747": 74, "51758": 83, "5179": 82, "51795": 82, "518": [75, 82, 84, 86, 95], "5181": 83, "51811": 82, "51821": 82, "51832": 81, "51841": 82, "51862": 82, "51878": 82, "519": [73, 76, 78, 81, 82, 86], "51956": 82, "5198": 85, "52": [40, 73, 78, 81, 82, 83, 84, 85, 86], "520": [73, 82, 86], "52026": 82, "52074": 82, "521": [78, 81, 82, 86], "52119": 82, "52160": 84, "52161": 84, "52191": 82, "522": [76, 78, 82, 86], "52200": 82, "52237": 84, "52255": 83, "52264": 82, "5227": 83, "523": [73, 82, 84, 86], "52311": 82, "52345": 82, "52354": 82, "5239": 86, "52397": 82, "524": [82, 86], "52445": 82, "5247": 82, "525": [76, 81, 82, 86, 95], "52554": 82, "52573": 83, "52596": 82, "526": [82, 85, 86], "52644": 82, "52645": 84, "52646": 84, "52671": 81, "52687": 82, "527": [76, 82, 84, 86], "52701": 82, "52714": 82, "52727": 84, "52734": 82, "52761": 82, "52769": 82, "52795": 81, "52798": 83, "528": [74, 76, 82, 86], "52804": 82, "5281": 82, "52842": 82, "52856": 81, "52887": 82, "529": [73, 85, 86], "5293": 82, "52974": 82, "53": [78, 79, 81, 82, 83, 84, 85, 86], "530": [82, 84, 86, 88], "53061": 82, "531": [82, 86], "5312": 86, "53176": 82, "532": [82, 86], "53203": 83, "53263": 82, "533": [74, 84, 86], "53322": 81, "534": [73, 76, 81, 86], "53407": 82, "5343": 86, "535": [75, 82, 86], "53596470096178": 3, "536": [82, 86], "5362": 81, "53633": 82, "5364": 86, "53669": 81, "537": [73, 86], "53738": 81, "538": [73, 82, 86], "53877": [40, 84], "539": [82, 85, 86], "53916": 81, "53938": 81, "53976": 84, "53e": 86, "54": [73, 74, 81, 82, 83, 84, 85, 86], "540": [74, 79, 86], "54045": 84, "541": [84, 86], "54143": 83, "5416": 81, "542": [82, 86], "54278": 83, "543": [2, 82, 86], "54359": 86, "54367": [40, 84], "54372": 84, "544": [73, 86], "54461": [40, 84], "54465": 83, "5448": 81, "545": [86, 95], "5450": 81, "54511": 84, "54522": 84, "54531": 83, "546": 86, "5463": 84, "54689": 84, "5469": 86, "547": 86, "5470": 81, "54736": 83, "5477": [82, 84], "548": [82, 86], "5481": 84, "54845": [40, 84], "5485": 81, "54879": 84, "549": [76, 81, 82, 86], "5491": 83, "54944": 81, "54992": 81, "55": [2, 73, 74, 78, 81, 82, 83, 85, 86, 88], "550": [73, 82, 86], "5500": 38, "55006": 83, "55025": 83, "55061": 84, "551": [82, 84, 86], "5513": 86, "55131": [86, 87], "5515": 86, "5519": 86, "552": [82, 86], "5520": 86, "55212": 81, "55289": 81, "553": 86, "55316": 82, "55331": 83, "5535": 84, "55378": 83, "554": [73, 86], "55413": 81, "555": [82, 86], "55579": 82, "556": [73, 86], "5563": 81, "557": [2, 81, 86], "5578": 86, "558": [82, 86, 95], "5583": 86, "5585": 86, "5588": 86, "55891": 83, "559": [82, 86], "5591": 86, "5595": 85, "56": [73, 75, 77, 78, 81, 82, 83, 84, 86], "560": [73, 84, 85, 86], "5604": 86, "561": [82, 85, 86], "56107": 82, "56122": 81, "56197": [86, 87], "562": [74, 82, 83, 86], "56215": 49, "5626": 86, "562e": 81, "563": 86, "564": [78, 84, 86], "5649": [82, 83], "565": [81, 86], "56529": 83, "5653": 82, "5659": 81, "566": [82, 83, 84, 86], "56625": 81, "567": [82, 86], "56722": 78, "56749": 83, "56765": 82, "5677": 82, "56777": 82, "56787": 82, "5679": 81, "56798": 82, "568": 86, "56809": 82, "56826": 82, "56838": 82, "56849": 82, "5685": 81, "56899": 82, "569": [73, 85, 86], "5690": 81, "56917": 81, "56933": 82, "56975": 82, "57": [73, 74, 78, 79, 81, 82, 83, 84, 85, 86], "570": [82, 86], "57026": 81, "57059": 82, "57076": 81, "571": [73, 82, 84, 86], "5715": 82, "57195": 81, "572": [73, 86], "57234": 81, "5725": 82, "573": 86, "5736": 82, "57376": 83, "574": 86, "57424": 84, "575": 86, "576": [81, 82, 86], "577": [73, 82, 86], "57758": 84, "57792": 84, "578": [82, 86], "57819": 81, "5782": 83, "5789": 88, "579": [81, 82, 85, 86], "57988": 82, "58": [73, 81, 82, 83, 84, 85, 86, 88], "580": 86, "5801": [83, 85], "58041": 83, "581": [86, 87], "58133": 82, "5819": [], "582": [84, 86], "58232": 84, "58238": 83, "583": 86, "58327e": 82, "584": [73, 86], "585": 86, "58521": 83, "586": [82, 86], "5869": 81, "587": [82, 86], "5875": [54, 81], "588": [76, 85, 86], "589": [82, 85, 86], "59": [74, 81, 82, 84, 85, 86, 88], "590": 86, "59074": 83, "591": [82, 86], "59145": 83, "5919306617286774e": 3, "592": [81, 82, 86], "5925": 35, "593": [73, 86], "59331": 81, "594": [84, 86], "595": [82, 86], "59561": 82, "596": [82, 86], "597": 86, "59713": 83, "5975": [40, 84], "5976": 86, "598": [73, 86], "599": [76, 82, 86], "5991": 81, "5992": 81, "5993": 86, "5994": [], "5e": [38, 88], "5e5": 63, "5i3l": 77, "5rel": 82, "5th": 77, "6": [1, 2, 3, 15, 18, 38, 40, 44, 45, 47, 51, 53, 59, 60, 63, 68, 69, 72, 73, 74, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96, 99], "60": [1, 40, 63, 73, 75, 78, 79, 82, 84, 85, 86, 96], "600": [53, 84, 86], "600614003857873": 3, "6009": 86, "601": [78, 82, 84, 86], "6013": 74, "602": [73, 76, 78, 82, 86], "6022": 82, "603": 86, "60375": 83, "604": 86, "605": [73, 86], "606": 86, "6069": 83, "607": [73, 78, 82, 86], "608": [73, 86], "60805": 81, "609": [81, 86], "60951": 83, "60967": 81, "61": [73, 74, 81, 82, 84, 85, 86], "610": [82, 86], "611": [81, 86], "61143": 82, "6115": 83, "612": [73, 86], "6121": 86, "613": [82, 86], "614": [84, 86], "615": 86, "616": [76, 83, 84, 86], "617": [84, 86], "61707": 81, "6172": [81, 82], "6178": 81, "618": [82, 86], "6180": 85, "61803": 82, "6182": 85, "6185": 85, "6186": 85, "619": [76, 86], "6192": 82, "62": [73, 78, 82, 84, 86, 95], "620": 86, "621": 86, "62128": 83, "621e": 86, "622": [73, 76, 81, 82, 86], "62208": 82, "622571": 74, "6227": 85, "6228": 85, "6229": 82, "623": [82, 85, 86], "624": [81, 82, 86], "6249": 82, "625": [76, 86], "6250": 84, "6254": 88, "626": [76, 86, 95], "62669": 78, "627": [82, 86], "627963": 74, "628": [73, 82, 84, 86], "629": [73, 82, 86], "62916": 83, "63": [73, 74, 81, 82, 84, 85, 86], "630": [82, 86], "63002": 83, "6304": 84, "631": [73, 74, 76, 85, 86], "6314": 0, "6317": 82, "632": 86, "6321": 81, "6328": 81, "633": [74, 86], "6334": 84, "634": [81, 82, 84, 86], "6341": 84, "635": [73, 86], "636": [73, 86], "637": [73, 74, 76, 83, 86], "6375": 81, "6376": 84, "6379": 82, "638": [82, 86, 95], "63827": 83, "639": [76, 86], "6395": 84, "64": [73, 74, 75, 78, 81, 82, 84, 86, 96], "640": [82, 86], "6405": 84, "6408": 83, "641": [83, 86], "6416": 84, "642": [73, 86], "6425": 86, "64259": 83, "643": [74, 86, 87], "6433": 81, "6435": 95, "644": [82, 86], "64495": 83, "645": 86, "6455": 82, "646": 86, "6461": 81, "64632": 83, "64633": 83, "647": [73, 86], "6476": 81, "648": [73, 82, 86], "64811": 82, "648603": 73, "64887": 83, "649": [82, 84, 86], "6490": 86, "6495": 74, "64e": [], "65": [73, 78, 81, 82, 84, 85, 86], "650": [73, 83, 86], "651": [85, 86], "6513": [], "652": [83, 86], "65283": 81, "653": 86, "654": [81, 84, 86], "655": 86, "6552": 78, "656": [81, 86], "6562": 82, "6569": 88, "65693038892429": 3, "657": [74, 84, 86], "657129890916668": 3, "65721": 83, "65796": 81, "658": [81, 85, 86], "6589": 81, "659": [82, 85, 86], "6591": 81, "659883": 86, "66": [78, 81, 82, 84, 85, 86, 87, 95], "660": [82, 86], "661": [82, 86], "662": [82, 86], "663": [73, 86], "664": 86, "6643": 82, "665": 86, "6651": 83, "666": [73, 76, 86], "667": [82, 86], "668": 86, "669": [82, 84, 86], "669628": 86, "67": [40, 73, 78, 82, 84, 85, 86], "670": [73, 86], "6705": 82, "671": [84, 86], "6714": 85, "67141": 74, "672": [73, 82, 86], "67233": 81, "673": [73, 82, 86], "6737": 82, "674": [76, 86], "6749": 88, "675": [81, 82, 86], "67537": 81, "676": [76, 86], "67612": 81, "6762": [], "677": 86, "678": 86, "678373": 77, "678570": 78, "678646": 78, "678848": 77, "67885": 81, "67891": 86, "678914": 77, "679": [73, 86], "679306": 78, "679516": 78, "679612": 78, "68": [40, 49, 73, 75, 78, 82, 84, 85, 86], "680": [81, 86], "6804": 81, "6806": 81, "681": [82, 86], "68191": 83, "68198": 83, "682": [78, 86], "683": 86, "684": [82, 86], "6841": 82, "685": [82, 86], "686": 86, "687": 86, "6874": 85, "6875": 85, "6878": 81, "688": [81, 82, 86], "6880": 81, "6885": 78, "689": [84, 86], "68902": 82, "69": [40, 73, 81, 82, 84, 85, 86, 87, 95], "690": 86, "69007": 83, "6902": 81, "691": 86, "6912": 86, "69191": 81, "692": [82, 86], "693": [83, 86], "694": 86, "695": [82, 86], "6956": 84, "6959": 86, "696": [73, 86], "6964": 84, "6965": 81, "6969": 81, "697": [81, 82, 86], "69743": 81, "698": 86, "6983": 88, "699": [73, 76, 82, 86], "7": [2, 3, 37, 40, 45, 46, 47, 48, 50, 51, 73, 74, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96], "70": [73, 74, 76, 82, 84, 85, 86, 95], "700": [1, 79, 82, 86], "7000": 11, "7002": [], "70048": 83, "701": [81, 86], "702": [82, 84, 86], "70272": 83, "703": [82, 86, 87], "704": [86, 87], "70452": 81, "705": [76, 79, 82, 86], "70558": [], "70559": 86, "7057": 83, "706": [73, 82, 86], "7062494437063": 3, "706694": 86, "707": [82, 86], "7070": 74, "7072": 81, "7075": 81, "70752": 81, "708": [73, 82, 86], "70801": 79, "7085": 83, "709": [85, 86], "71": [40, 73, 74, 79, 81, 82, 83, 84, 85, 86, 95], "710": [73, 86], "711": [82, 86], "712": [82, 86], "713": [82, 86], "71331": 83, "714": [73, 86], "7142": 83, "715": [73, 82, 86], "7159": [], "716": [82, 84, 86], "717": [82, 84, 86], "71785": 81, "718": [73, 86], "719": [73, 84, 86], "72": [18, 40, 69, 73, 74, 79, 81, 82, 83, 84, 86, 87, 95], "720": 86, "721": [82, 86], "72162": 81, "722": [73, 82], "723": 86, "7235": 81, "724": 76, "7241": 81, "72428": 81, "72438": 83, "725": [82, 84, 85], "726": 86, "7267": 81, "727": [82, 84, 86], "72705": 81, "728": [76, 82], "7289": 81, "729": 81, "7293": 81, "72e": 84, "73": [73, 74, 81, 82, 83, 84, 86], "730": [82, 86], "731": [82, 86], "73284": 81, "733": [86, 87], "734": [82, 84], "735": [73, 82, 86], "736": [73, 77, 82, 84, 86], "737": 82, "73719": 83, "738": 82, "738e": 82, "739": [73, 77], "74": [40, 74, 75, 78, 79, 81, 82, 84, 86, 95], "740": [82, 85], "74028": 86, "741": 73, "7410": 85, "742": [83, 84], "7429": 88, "743": 82, "7432": 84, "74323": 84, "744": 73, "745": 81, "74578": 83, "746": [73, 74, 78, 82, 86], "747": 84, "7478": [40, 84], "7479": 86, "748": [82, 86], "749": [76, 84], "7490": 78, "74952": 84, "75": [12, 45, 54, 73, 78, 79, 81, 82, 84, 85, 86, 95], "750": 84, "75074": 84, "75085": 84, "751": [73, 82], "752": [72, 73, 84, 95], "7521": 81, "75377": 84, "754": 84, "75406": 84, "75442": 84, "75458": 83, "755": [73, 82], "75607": [40, 84], "7571": 82, "758": [76, 81, 82], "759": 82, "7599": 81, "76": [11, 73, 74, 78, 79, 81, 82, 84, 85, 86, 95], "760": [73, 82, 85], "7603": 74, "76079": [40, 84], "7608": 81, "761": 73, "76136": 83, "762": 82, "7620": 82, "763": [73, 85], "7630": 85, "7632": 85, "7634": [], "764": 82, "7644": 81, "76468": [40, 84], "7648": 86, "765": 82, "76579": 84, "766": 82, "7676": 82, "769": [72, 73, 84, 95], "77": [73, 74, 75, 78, 79, 81, 82, 84, 85, 86, 87], "770": 76, "771": 81, "772524827250213e": 3, "773": [74, 76, 84], "774": 82, "7747": 81, "7749": 81, "775": [73, 82, 84, 85], "777": [73, 82], "77775": 83, "778": 81, "778243": 74, "77983": [40, 84], "78": [73, 74, 76, 77, 79, 81, 82, 83, 84, 85, 86, 95], "780": 82, "781": 84, "7811": 82, "78117": 84, "7812": 85, "7813": 85, "781e": 86, "782563": 74, "783": 82, "78346": 79, "7837": 82, "7844": 82, "785": 82, "7854": 82, "786": [81, 82, 86], "7863": 82, "787": 74, "7872": 82, "78839": 83, "79": [1, 53, 73, 76, 79, 81, 82, 83, 84, 85, 86], "790": [73, 86], "79025": 73, "791": 73, "79118": 83, "7919": 81, "792": [84, 85], "793": 76, "79369": 84, "794": [73, 82, 85, 86], "79464": [], "79465": 86, "79472": [], "79473": 86, "79481": [], "79482": 86, "79493": [], "79494": 86, "795": 82, "79501": [], "79502": 86, "79527": [], "79528": 86, "79544": [], "79545": 86, "796": 73, "79619": [], "7962": 86, "79677": 86, "797": 82, "7975": 82, "798": 73, "799": [73, 82], "7beq": 74, "7e": 88, "8": [1, 2, 11, 22, 40, 44, 47, 49, 53, 63, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95], "80": [12, 33, 40, 73, 78, 79, 81, 82, 84, 85, 86, 87], "800": [73, 82], "80027": 83, "80046": [], "80047": 86, "801": 76, "801406_1": 73, "801574_1": 73, "802": [73, 81, 82], "802003_1": 73, "80208": 81, "803": 82, "804": 82, "80437": 83, "805": [73, 82], "806": [82, 85], "8072": 76, "808": [73, 82, 86], "809": 82, "81": [73, 74, 79, 81, 82, 84, 85, 86], "81007": 86, "810542_1": 73, "811": [74, 82, 85], "812": [73, 82], "8125": [48, 82], "813": 82, "81377": 83, "814": [74, 82], "81495": 81, "815": 84, "81509": [], "8151": 86, "81589": 83, "816": [73, 82, 84], "817": [73, 82], "8170": 82, "818": [84, 85], "81814": 83, "8183": 82, "8184": 82, "819": [82, 84], "82": [18, 69, 73, 78, 79, 81, 82, 84, 85, 86, 95], "820": 84, "821": 82, "82146": 83, "822": [82, 86], "823": 76, "8234": 86, "824": [76, 84], "8256": 86, "826": 82, "8264": 83, "827": 73, "8270": 86, "828": 82, "82846": 81, "829": 82, "8298": [], "82981": 86, "82988": [], "82989": 86, "82e": 84, "83": [73, 78, 82, 84, 85, 86], "830": 74, "831": [73, 76, 81, 82, 84], "83106": [83, 86], "83161": 86, "832": 84, "8325": [40, 84], "83299": 86, "833": [75, 82, 85], "8339": 83, "834": [81, 84, 86], "835": 82, "8353": 81, "8365": 73, "8366": [], "83667": [], "83668": 86, "837": 82, "838": 84, "839": [77, 83], "84": [73, 74, 81, 82, 84, 85, 86, 87], "840": 85, "8417": 86, "842": [73, 78, 82], "8429": 86, "843": [76, 86], "8436": 82, "845": [84, 85], "846": [82, 84], "84699": 82, "847": 84, "848": 82, "849": 82, "84910": 73, "8498": 73, "85": [73, 75, 76, 78, 79, 81, 82, 84, 85, 86, 95, 96], "8507": 76, "851": [73, 82], "852": 82, "853": 82, "8531": 73, "85351": 81, "854": [76, 82], "8541": 86, "85448": 81, "8545": [40, 84], "855": 82, "8559": 83, "856": [73, 82], "857": 82, "8570": 82, "85708": 81, "8572": 82, "8575": 82, "858": 82, "859": 82, "86": [73, 82, 84, 85, 86], "860": 82, "861": 82, "86348": 83, "8636": 84, "864": [76, 84], "865": [73, 82, 84], "8650": 76, "86526": 81, "8654": 84, "866": [73, 76, 84], "867": 82, "8672": 82, "868": 82, "869": 73, "8693": 82, "86945": 83, "86962": 82, "87": [73, 76, 78, 81, 82, 83, 84, 85, 86], "870": 73, "871": [82, 83], "872": 84, "873": [73, 82], "87496": 83, "875": 82, "876": 73, "877": [82, 95], "8777": 82, "878": [82, 84], "879": [73, 82], "88": [73, 74, 78, 81, 82, 84, 85, 86], "880": 82, "8800": 81, "8807": 83, "881": [73, 82, 85, 86], "8813": 82, "883": [84, 86], "884": 84, "885": [73, 84], "88594": 86, "88595": [], "886": [74, 78, 82, 83, 84], "8863": 85, "887": [82, 87], "8871": 85, "8873": 82, "8876": [], "888": [73, 82], "889": [82, 84], "8896": [40, 84], "89": [74, 75, 77, 78, 79, 82, 83, 85, 86, 87], "890": [73, 86], "891": [73, 82, 86], "892": 76, "893": [82, 85, 86], "894": [82, 95], "895": 85, "8951": 82, "8952": 81, "8957": 82, "896": 82, "89652": 86, "897": [73, 82, 84], "8970": 82, "898": [76, 82], "8986": 81, "8996": 82, "8997": 82, "8e": [40, 84], "8m3": 83, "9": [3, 11, 40, 45, 52, 53, 73, 74, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95], "90": [1, 40, 45, 46, 47, 50, 51, 53, 54, 73, 74, 75, 76, 77, 78, 79, 81, 82, 84, 85, 86, 87, 88, 95, 96], "900": [73, 82], "9000": 82, "901": [82, 86], "9013": 85, "9018": 81, "902": 82, "903": [81, 84], "9033": 82, "9039": 82, "904": [82, 85], "904199434387693e": 3, "90458": 83, "905": [73, 82], "9054": 82, "906": [73, 82, 84, 86], "907": [82, 84, 86], "90710": 86, "908": [73, 82], "90807": 83, "90889": 86, "909": [82, 86, 87], "91": [78, 82, 84, 85, 86], "910": [73, 82, 84], "91089": 86, "911": [73, 82], "91153": 86, "912": [82, 84, 85], "91203": 86, "91236": 83, "9124": 82, "9126": 82, "91362": 81, "914": [73, 82, 86], "915": 73, "9155": 76, "91555": [], "91556": 86, "91579": 83, "91595": [], "91596": 86, "916": [38, 82], "917": [38, 73, 82], "918": [82, 84], "91895": 86, "919": [74, 82, 86], "91913": 83, "9195": 82, "92": [49, 73, 74, 76, 79, 81, 82, 84, 85, 86, 95], "920": [73, 82, 84], "92029": 86, "92093": 86, "921": [73, 82], "9212": 81, "9213": 81, "92165": 86, "92194": 81, "922": [82, 84, 86], "9222": [40, 84], "92296": 86, "923": 82, "9239": 86, "924": 83, "9244": 85, "9245": 85, "925": [84, 86], "9253": 86, "92639": 86, "9265": 82, "92656": 86, "927": [81, 82, 84, 86], "928": [82, 84], "9281": 74, "9283": [], "929": [82, 84, 86], "92940": 86, "93": [76, 78, 81, 82, 84, 85, 86, 88, 95], "930": 81, "9301": 86, "93047": 86, "93092": 86, "931": [73, 76], "93126": 86, "93138": 86, "932": [40, 73, 82, 84], "93248": 86, "933": [40, 82, 84], "93302": 86, "93340": 86, "93360": 86, "934": [40, 82, 84], "93419": 86, "935": 73, "9351": 82, "9352": 83, "93595": 86, "936": [40, 74, 82, 84], "937": [73, 82, 84, 85, 86], "93703": 86, "93709": 86, "93712": 86, "93742": 86, "93749": 86, "93816": 86, "93838": 86, "9385": 81, "9386": 81, "93862": 86, "93867": 86, "93870": 86, "93872": 86, "93886": 86, "93890": 86, "939": [73, 83, 86], "93959": 86, "93960": 86, "93970": 86, "94": [73, 74, 76, 81, 82, 84, 85, 86, 87, 96], "940": 82, "94017": 86, "94031": 86, "94057": 86, "94063": 86, "94065": 86, "94077": 86, "94089": 86, "94097": 86, "941": [73, 82, 84], "94101": 86, "94103": 86, "9414": 82, "94166": 86, "94172": 82, "94173": 86, "94187": 83, "94188": 86, "94194": 86, "942": [73, 76, 82, 84], "94215": 86, "94275": 86, "943": [73, 82, 84, 85], "94373": 86, "944": [82, 83, 84], "945": [82, 84], "9452": 84, "946": [76, 82], "947": [73, 76, 82, 84], "948": [82, 84, 86], "94809": 81, "949": 84, "95": [1, 37, 40, 45, 54, 63, 69, 73, 76, 81, 82, 84, 85, 86], "950": [74, 82], "95027": 81, "9504": 81, "95064": 82, "95067": 82, "95093": 82, "951": [73, 75, 82, 84], "95156": 82, "952": [75, 82, 84, 86], "9522": 81, "95249": 82, "953": [40, 73, 74, 82, 84], "954": [73, 78, 82], "95430": 86, "95431": 86, "95432": 86, "95478": 82, "955": 82, "956": [73, 75, 85], "9560": 86, "9567": 81, "95684": [86, 87], "95685": [], "95698": [], "95699": 86, "957": [73, 84], "9574": [], "958": [82, 84], "959": [81, 82, 85, 86], "9593": 81, "95999": 82, "96": [40, 73, 76, 78, 81, 82, 84, 85, 86, 88, 96], "960": [73, 75], "961": [73, 82, 84, 86], "9614": 86, "962": [84, 85], "963": [82, 84], "964": [73, 82, 86], "9645": 81, "965": 73, "965028": 86, "96574": 86, "966": [73, 82], "96614": 82, "967": 84, "9672": 86, "9673": 86, "968": [73, 84, 86], "96848": 83, "969": [82, 84, 85], "97": [40, 73, 74, 76, 78, 79, 81, 82, 84, 85, 86, 87, 95], "970": 73, "971": [73, 81, 82, 83, 84], "9712": 81, "9716": 86, "972": [82, 86], "97204": 83, "9721": 95, "9722": 86, "9725": 86, "97255": 82, "972795822746061": 3, "9728": 86, "973": [76, 82, 85], "97306": 83, "9731": 86, "974": [74, 81, 84], "97476": 83, "975": [41, 51, 53, 54, 58, 59, 60, 69, 73, 81, 84], "9752": 86, "976": [82, 86], "97625": 79, "9765": 78, "977": [81, 82, 84, 85], "9778": 85, "978": [0, 82, 84, 85, 86], "9783": 86, "979": [73, 82, 85, 86], "97949": 85, "979493": 84, "9795": 3, "98": [73, 74, 75, 76, 78, 79, 81, 82, 84, 85, 86, 87], "980": [73, 82], "9802": 82, "98056": 83, "981": [82, 83, 85], "9810": 86, "9811": [], "9812": [], "9814": 85, "9815": [], "982": [84, 85], "983": [73, 82, 84, 85], "9833": 82, "98356": 86, "9838": 82, "984": [81, 82, 86], "98416": 78, "98469": 81, "985": [86, 88], "9850": 85, "986": [73, 84, 85], "987": [82, 83, 84, 86], "988": [73, 82, 85, 86], "9881": 86, "989": [73, 82], "9895": 82, "9899": 82, "99": [44, 69, 73, 74, 76, 77, 78, 79, 82, 83, 84, 85, 86, 87, 96], "990": [73, 82, 84], "9907": 82, "991": [73, 82, 84, 86, 88], "9914": 78, "99161": 82, "992": [73, 76, 84, 85], "99298": 82, "993": [73, 74, 76, 82, 84, 85], "9931": 82, "99366": 82, "9938": 86, "994": [73, 76, 84], "99429": 82, "9943": 79, "9945": 82, "99453": 82, "9949": 86, "995": [73, 76, 82, 85, 86], "996": [73, 76, 78, 82, 83, 84, 86], "9961": 86, "997": [76, 82, 84, 85, 86], "997300": [41, 51, 54, 58], "998": [73, 79, 82, 84, 86, 87], "9982": 86, "99873": 86, "99874": 84, "99889": 86, "99893": 86, "99897": 86, "99898": 84, "99899": 86, "999": [3, 21, 82, 84, 86, 87], "99904": 84, "99909": 84, "99914": 84, "99916": 84, "9992": 84, "99921": 84, "99926": 84, "99952334925477": 3, "999803": 75, "9999": [44, 84], "999913": 86, "999939": 86, "9999551354884303": 3, "9999691721195861": 3, "999994": 82, "999997269169901": 3, "999998": 82, "999999": 44, "9999999": 44, "9m": 76, "9m56": 83, "A": [0, 1, 2, 3, 4, 6, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 30, 31, 33, 35, 40, 43, 44, 47, 49, 52, 53, 54, 59, 60, 61, 63, 70, 72, 73, 74, 75, 78, 80, 81, 82, 84, 85, 86, 88, 92, 93, 94, 95, 96, 97], "AND": [33, 92], "AS": [92, 95], "AT": 95, "And": 88, "As": [1, 2, 4, 7, 35, 40, 44, 47, 74, 78, 79, 81, 82, 83, 84, 85, 86, 87, 96, 97], "At": [0, 2, 7, 53, 59, 60, 74, 77, 78, 81, 82, 83, 86, 87, 88, 97], "BE": 92, "BUT": 92, "BY": 92, "But": [74, 84], "By": [1, 2, 7, 34, 52, 53, 55, 59, 60, 61, 63, 66, 68, 70, 74, 76, 81, 82, 83, 84, 85, 86, 87, 88], "FOR": 92, "For": [1, 2, 7, 9, 11, 14, 15, 38, 41, 42, 44, 47, 48, 51, 52, 53, 54, 55, 58, 59, 60, 72, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 88, 90, 91, 96], "IF": 92, "IN": 92, "If": [1, 4, 7, 9, 11, 14, 15, 16, 18, 22, 24, 33, 34, 35, 38, 40, 43, 44, 46, 47, 48, 50, 52, 53, 54, 59, 60, 63, 64, 66, 68, 69, 70, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 96], "In": [0, 1, 2, 4, 7, 11, 14, 15, 21, 23, 40, 47, 52, 53, 54, 59, 60, 61, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 97], "It": [2, 3, 11, 14, 35, 37, 40, 41, 50, 53, 54, 59, 60, 63, 71, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87], "Its": [2, 36], "NO": 92, "NOT": [18, 92], "Near": 74, "No": [38, 40, 82, 83, 84, 85, 86, 96], "Not": [38, 45, 51, 52, 53, 59, 60], "OF": 92, "ON": 92, "OR": 92, "Of": 2, "On": [2, 49, 74, 75, 77, 83, 87], "One": [1, 38, 74, 75, 76, 78, 83], "Or": [71, 91], "SUCH": 92, "Such": [2, 88], "THE": 92, "TO": 92, "That": [2, 14, 74, 83], "The": [0, 1, 3, 4, 6, 7, 9, 11, 12, 14, 15, 16, 17, 18, 22, 23, 24, 25, 26, 29, 30, 31, 33, 35, 36, 38, 40, 41, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 57, 58, 59, 60, 61, 62, 63, 64, 66, 69, 70, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 91, 93, 94, 95, 96, 97, 98], "Then": [9, 14, 53, 59, 60, 75, 76, 82, 86, 87, 91, 96], "There": [1, 2, 7, 9, 74, 75, 76, 77, 78, 81, 82, 83, 86, 87, 90, 97], "These": [1, 2, 3, 4, 14, 15, 33, 38, 48, 53, 60, 63, 74, 75, 76, 78, 80, 82, 83, 84, 86, 87, 96], "To": [0, 1, 2, 4, 7, 11, 14, 47, 49, 74, 75, 77, 78, 82, 83, 84, 85, 86, 87, 91, 93, 96, 97], "Will": 1, "With": [14, 35, 73, 74, 75, 76, 81, 83], "_": [2, 22, 35], "_0": 35, "_1": [2, 35], "_2": 2, "_3": 2, "__cxx11": [22, 23, 24, 25, 26], "__future__": [4, 6], "__id__": 3, "__init__": [4, 6, 10, 11, 12, 14, 15, 16, 17, 18, 22, 23, 24, 25, 26, 30, 31, 33], "__main__": [6, 83], "__name__": [6, 83], "_compon": 4, "_detector": 26, "_do_outlier_reject": 15, "_goniomet": 4, "_goniometer_factori": 4, "_i": [2, 35], "_n": 2, "_object": [10, 12, 14, 22, 23, 24, 25, 26], "_outlier_indic": 15, "_processor": 12, "_processorrot": 12, "_reindex": 40, "_rmsds_core": 14, "_src_path_root": 4, "_\u03ba": 2, "_\u03c6": 2, "_\u03c9": 2, "a1": [18, 82, 86], "a2": [7, 18, 96], "a222": 77, "aaron": 0, "ab": [2, 82, 84, 86], "abandon": 79, "abbei": 74, "abc": 2, "abil": 42, "abl": [40, 82, 86, 87], "abnorm": 84, "about": [2, 4, 7, 14, 15, 23, 25, 47, 48, 57, 62, 74, 76, 78, 81, 82, 83, 84, 85, 86, 87, 98], "abov": [1, 4, 9, 37, 38, 40, 41, 44, 47, 51, 54, 58, 63, 69, 70, 73, 74, 76, 82, 84, 86, 87, 88, 92], "abraham": [75, 95], "abruptli": 83, "absenc": [35, 69, 72, 79, 82, 84, 86, 88], "absent": [18, 40, 68, 72, 82, 84, 85, 86], "absolut": [1, 18, 30, 44, 53, 59, 60, 72, 83, 84], "absolute_angle_toler": [11, 18, 40, 53, 69, 72], "absolute_cutoff": [14, 53, 59, 60], "absolute_import": 4, "absolute_num_interv": [53, 59, 60, 73, 75], "absolute_toler": 33, "absorb": 63, "absorpt": [1, 15, 35, 54, 63, 72, 82, 84, 86, 87, 88], "absorption_correct": [1, 54, 63], "absorption_level": [1, 63, 72, 88], "abspath": 83, "abstract": [0, 2, 14, 15], "ac": [2, 91, 95], "ac02": [0, 90], "acad": 95, "accept": [2, 7, 14, 47, 50, 51, 53, 72, 73, 82, 84, 86, 87], "access": [1, 9, 14, 21, 48, 81, 83, 87, 90], "accessor": 14, "accord": [11, 14, 18, 42, 46, 47, 76], "accordingli": 77, "account": [1, 2, 35, 47, 50, 51, 82, 84, 86, 87, 88], "accumul": [0, 12, 18], "accur": [14, 47, 50, 51, 73, 78, 83, 88, 95, 97], "accuraci": [53, 59, 60], "acentr": 84, "achiev": [7, 14, 35, 53, 56, 59, 60, 81, 88], "acronym": 44, "across": [0, 1, 43, 53, 59, 60, 63, 72, 74, 75, 82, 84, 88, 96], "act": [47, 51, 66], "acta": [0, 2, 11, 18, 40, 69, 72, 75, 79, 84, 95], "action": [53, 59, 60], "actual": [2, 14, 15, 73, 76, 81, 83, 86], "ad": [33, 44, 59, 70, 73, 74, 76, 81, 82, 86, 94], "ada": 94, "adam": [0, 2, 11, 95], "adapt": [14, 75, 94], "adaptlbfg": [14, 19], "adaptlstbx": [14, 19], "add": [4, 9, 10, 12, 14, 15, 29, 33, 44, 47, 53, 73, 76, 82, 86, 87, 91, 96], "add_batch_list": [32, 33], "add_column": 14, "add_constant_to_diagon": 14, "add_cryst": 33, "add_dataset": 33, "add_empty_dataset": 33, "add_experi": 33, "add_group": 23, "add_panel": 23, "add_row": 14, "addit": [0, 1, 7, 14, 15, 26, 33, 41, 43, 44, 46, 47, 49, 53, 54, 59, 60, 63, 75, 81, 82, 84, 86, 87, 88, 94, 96], "addition": [14, 82, 84, 86], "additional_stat": 63, "address": [0, 78, 84, 97], "addsym": 73, "adher": [82, 86, 87], "adjust": [1, 73, 74, 75, 82, 84, 86, 87, 88], "adob": 71, "adopt": 2, "advanc": [16, 80, 82, 83, 86, 87, 89, 97], "advantag": [82, 83, 86, 87], "adventur": 97, "advic": [0, 77], "advis": [1, 92], "adxv": [81, 86], "ae": 95, "af": [10, 12, 14, 23, 24, 25, 26], "affect": [1, 42, 53, 59, 60, 72, 74, 75, 78, 82, 83, 84, 86, 87], "after": [0, 1, 14, 18, 35, 39, 44, 48, 53, 54, 59, 60, 61, 63, 66, 72, 73, 74, 75, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96], "ag": 85, "again": [73, 74, 78, 81, 82, 83, 85, 86, 87, 88, 93], "against": [11, 15, 18, 47, 59, 63, 70, 76, 77, 81, 82, 83, 86, 88, 89], "aggreg": 11, "agre": [1, 2, 76], "agreement": [53, 82, 84, 86, 87, 88], "aguila": 95, "ah": 95, "ahead": [26, 74, 77, 78, 83], "ai": 95, "aim": [1, 76, 88], "aimless": [1, 44, 75, 82, 84, 86, 87], "ak": 74, "al": [11, 64, 72, 79, 84], "albula": 81, "alcv": 83, "algorithm": [0, 1, 2, 4, 31, 32, 38, 40, 41, 42, 47, 50, 51, 53, 54, 58, 59, 60, 63, 71, 74, 78, 81, 82, 83, 84, 85, 86, 87, 90, 94, 95, 96, 98], "alguel": 83, "alia": [11, 12, 15, 33, 63], "align": [2, 11, 21, 23, 25, 34, 75, 76, 77, 78, 88], "align_cryst": 71, "all": [0, 1, 2, 3, 4, 7, 11, 14, 15, 18, 23, 24, 25, 26, 33, 35, 38, 40, 44, 45, 47, 48, 49, 51, 52, 53, 54, 59, 60, 62, 63, 64, 68, 69, 70, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 92, 96], "all_lau": 24, "all_rot": 24, "all_sequ": 24, "all_stil": 24, "all_tof": 24, "aller": [83, 95], "alloc": [22, 23, 24, 25, 26, 54], "allow": [1, 3, 11, 14, 16, 18, 23, 24, 34, 38, 44, 46, 48, 52, 53, 59, 60, 61, 63, 73, 74, 75, 76, 77, 81, 82, 83, 86, 87, 88, 90, 93, 94, 96], "allow_multiple_sequ": [52, 93], "allow_non": [35, 37, 38, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 58, 59, 60, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "almost": [53, 74, 76, 77, 82, 86], "along": [2, 11, 23, 33, 34, 40, 52, 53, 74, 75, 77, 81, 84], "alongisd": 63, "alongsid": [1, 73, 93], "alonso": 95, "alpha": [2, 25, 40, 53, 59, 60, 84, 88], "alpha_i": 35, "alreadi": [1, 4, 14, 16, 21, 23, 25, 26, 29, 53, 59, 60, 63, 72, 74, 76, 78, 82, 84, 86, 87, 88], "also": [1, 2, 3, 4, 7, 9, 11, 14, 15, 18, 21, 22, 23, 25, 26, 33, 37, 44, 48, 53, 59, 60, 61, 63, 66, 68, 70, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 91, 96], "alter": [45, 74, 76, 87], "altern": [1, 4, 7, 11, 52, 53, 59, 60, 61, 63, 66, 77, 79, 82], "although": [1, 38, 60, 73, 75, 77, 78, 81, 82, 83, 86, 87, 93], "altogeth": 18, "altruism": 0, "alun": [0, 97], "alwai": [1, 9, 47, 54, 77, 78, 83, 87], "ambigu": [18, 40, 61, 72, 76, 77, 84, 95], "ami": 0, "ammaar": 0, "amongst": [42, 83], "amount": [35, 41, 51, 54, 58, 63, 73, 84], "amplif": 84, "amplifi": 14, "amplitud": [33, 63, 77, 84, 85], "amyloid": 95, "an": [1, 2, 3, 4, 7, 9, 11, 14, 15, 16, 18, 21, 23, 24, 25, 26, 29, 30, 31, 33, 35, 37, 38, 40, 41, 42, 43, 44, 45, 46, 47, 48, 50, 51, 52, 53, 54, 58, 59, 60, 61, 62, 63, 64, 66, 67, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 90, 93, 95, 96, 97], "analogi": 2, "analys": [18, 37, 40, 52, 53, 59, 60, 74, 82, 83, 84, 86, 87, 90], "analyse_output": 81, "analysi": [14, 18, 37, 40, 49, 53, 56, 59, 60, 63, 69, 72, 77, 78, 80, 81, 85, 87, 88, 90, 95, 96, 97], "analysis_lev0": 81, "analysis_lev1": 81, "analytical_correct": 63, "analyz": 48, "anastassi": 97, "ancestor": 4, "andrei": 77, "andrew": [0, 40, 84, 97, 98], "ang": 53, "angl": [2, 6, 11, 18, 21, 23, 25, 33, 39, 40, 52, 53, 54, 60, 63, 68, 69, 70, 72, 73, 74, 76, 82, 84, 86, 87, 88], "angle_toler": 22, "angstrom": [1, 11, 41, 47, 50, 51, 53, 54, 58, 72, 77, 78, 81, 82, 83, 84, 86, 87], "angular": [2, 11, 18, 53, 59, 60, 81, 82, 86], "ani": [3, 7, 11, 14, 15, 18, 24, 33, 38, 40, 44, 47, 49, 52, 53, 59, 60, 61, 63, 66, 72, 74, 76, 77, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 92, 93], "anisotrop": [18, 84], "anisotropi": 84, "annlib": 33, "annlib_adaptbx": 33, "annot": 6, "annoy": 83, "anom_amplitud": 33, "anom_arrai": 33, "anom_multipl": 33, "anomal": [1, 33, 43, 63, 72, 74, 76, 79, 82, 84, 86, 87, 88], "anoth": [1, 53, 61, 74, 75, 78, 82, 84, 86, 96], "ansitowin32": 33, "answer": 84, "anticip": [35, 82, 86], "anvil": 35, "anvil_correct": 71, "anyon": 0, "anywai": [82, 86, 87], "ap": [73, 74, 77, 78, 79, 82, 85, 86], "apach": 71, "apache_install_di": 48, "apart": [7, 81, 82, 86, 87], "api": [22, 24, 25, 26, 83], "app": 79, "appar": [76, 81, 86, 87], "apparatu": [2, 4], "appear": [2, 29, 36, 45, 71, 73, 74, 76, 79, 82, 84, 86, 87], "append": [4, 11, 14, 24, 44], "appendix": 18, "appl": [2, 11, 40, 64, 79, 84, 95], "appli": [0, 1, 3, 4, 11, 14, 15, 18, 21, 24, 46, 52, 53, 54, 59, 60, 61, 63, 72, 73, 75, 76, 78, 82, 83, 84, 86, 87, 88], "applic": [44, 54, 72, 73, 82, 84, 86, 87, 91], "apply_hkl_offset": 11, "apply_mask": 71, "apply_symmetri": 11, "appreci": 11, "approach": [1, 11, 76, 95], "appropri": [2, 7, 11, 12, 14, 15, 23, 40, 43, 53, 59, 60, 63, 66, 74, 75, 76, 79, 81, 83, 84, 87, 88], "approxim": [14, 35, 37, 43, 63, 72, 74, 77, 81, 84], "apr": [48, 95], "aquila": 74, "ar": [0, 1, 2, 3, 4, 7, 9, 11, 14, 15, 16, 18, 22, 23, 24, 25, 26, 33, 35, 38, 40, 41, 43, 44, 46, 47, 48, 51, 52, 53, 54, 55, 57, 58, 59, 60, 61, 62, 63, 65, 66, 69, 70, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 91, 92, 93, 94, 95, 96, 97], "arb": 95, "arbitrari": 31, "arbitrarili": 2, "arc": [51, 74], "architectur": 95, "archiv": [7, 75, 78], "area": [1, 47, 74, 84, 86, 87, 97], "aren": 40, "arg": [4, 11, 14, 24, 33], "arg1": [10, 12, 14, 22, 23, 24, 25, 26], "arg2": [10, 12, 22, 23, 24, 25, 26], "arg3": [10, 12, 23, 24, 25, 26], "arg4": [10, 12, 25, 26], "arg5": [10, 12, 25], "arg6": [10, 25], "arg7": 25, "argpars": 33, "argu": [2, 84], "argument": [7, 14, 15, 26, 31, 33, 52, 53, 64, 66], "argumenthandlingerrorinfo": [32, 33], "argumentpars": [6, 32, 33], "argumentparserbas": [32, 33], "argv": 83, "aris": 92, "arm": 25, "around": [1, 18, 34, 47, 50, 51, 53, 59, 60, 74, 76, 78, 83, 87, 97], "arrai": [1, 4, 11, 14, 15, 18, 32, 33, 42, 54, 55, 63, 72, 90, 97], "arrang": [2, 81, 84], "array_famili": [3, 4, 11, 83], "arrayscalingmodel": 15, "art": [74, 87], "artefact": 81, "articl": 74, "as_dict": 18, "as_fil": 24, "as_grid_scan": 52, "as_imageset": 26, "as_json": [18, 24], "as_str": 22, "ascii": [3, 74, 87], "ascrib": 11, "ashton": [0, 95, 97], "asid": 78, "ask": [48, 76, 83, 84], "asmit": 0, "aspect": [2, 75], "assembli": 74, "assert": [6, 52], "assert_is_compatible_unit_cel": 22, "assess": [11, 48, 73, 74, 76, 82, 83, 84, 86, 87, 96], "assign": [11, 22, 53, 72, 77, 82, 83, 84, 86, 87, 88], "assign_indic": 11, "assignindicesglob": 11, "assignindicesloc": 11, "assignindicesstrategi": 11, "assmann": 84, "associ": [4, 11, 14, 15, 53, 59, 60, 68, 83, 93, 95], "assum": [1, 2, 7, 14, 21, 22, 23, 25, 29, 35, 37, 46, 48, 74, 75, 79, 81, 83, 84, 88], "assumpt": [1, 23, 35, 76, 78, 83], "assur": 53, "asu": [37, 73], "asymmetr": [44, 56, 77, 94], "asymptot": [82, 84, 86], "atom": [2, 63, 76, 84], "attach": 25, "attempt": [4, 24, 34, 35, 53, 63, 76, 83, 88, 96], "attende": 99, "attent": [74, 76, 87], "attenu": 35, "attribut": [14, 15, 33], "attributes_level": 7, "aug": 95, "augment": 36, "author": 73, "auto": [1, 11, 18, 40, 44, 45, 47, 49, 51, 52, 53, 54, 59, 60, 62, 63, 64, 69, 72, 82, 83, 86, 87], "auto_reduct": [53, 59, 60], "autoindex": [53, 79, 82, 86, 87], "autom": [84, 97], "automat": [1, 9, 11, 18, 33, 40, 48, 53, 59, 60, 66, 72, 74, 75, 79, 82, 83, 84, 85, 86, 87, 88, 95], "automatic_default_fre": 79, "automatic_default_scaled_unmerg": 79, "autotyp": 18, "auxiliari": 14, "avail": [0, 1, 4, 9, 14, 21, 26, 35, 47, 54, 63, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 91, 94, 96], "averag": [1, 38, 42, 55, 63, 82, 86, 87], "average_detector": 38, "average_hierarchy_level": 38, "avoid": [0, 14, 33, 53, 59, 60, 72, 74, 81, 82, 83, 86], "aw": 95, "awai": [75, 81], "awkward": 74, "ax": [2, 14, 25, 34, 35, 52, 57, 62, 74, 75, 76, 78, 84], "axford": [11, 83, 95], "axi": [2, 4, 6, 21, 22, 23, 25, 33, 34, 38, 52, 53, 59, 60, 72, 73, 75, 76, 77, 78, 82, 84, 85, 86, 87], "axial": [69, 88], "axis_and_angle_as_r3_rotation_matrix": 6, "a\u00b2": [82, 84, 86], "b": [1, 2, 14, 15, 18, 21, 22, 40, 53, 59, 60, 61, 63, 72, 73, 74, 76, 77, 78, 79, 81, 82, 84, 85, 86, 87, 88, 95], "b_cart": [82, 84, 86], "b_factor": 11, "b_iso": [11, 53], "ba": 95, "bacaj": 95, "back": [1, 54, 63, 73, 74, 76, 81, 83, 87], "background": [3, 19, 31, 32, 41, 47, 51, 54, 74, 78, 82, 85, 86, 87, 95], "background_gradi": 47, "background_s": [16, 47], "backgroundgradientfilt": [16, 19], "backstop": 81, "bacteri": 95, "bad": [14, 54, 74, 78, 79, 81, 82, 83, 84, 86, 87, 93], "bad_refer": 54, "badli": [78, 87], "bag": 84, "bagtrain": 84, "balanc": 48, "band": [53, 74], "bandwidth": 53, "bank": 74, "bar": 33, "barn": 95, "base": [0, 1, 4, 9, 10, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 30, 31, 33, 38, 43, 46, 53, 59, 60, 63, 64, 70, 79, 82, 83, 84, 86, 87, 88, 95, 97], "base_package_opt": 33, "bash": [7, 74, 75, 76, 83], "basi": [2, 11, 18, 24, 39, 53, 60, 61, 73, 74, 76, 77, 82, 83, 84, 85, 86, 88], "basic": [1, 2, 7, 14, 76, 82, 84, 86, 87], "basic_imageset_from_dict": [27, 30], "basic_imageset_to_dict": [27, 30], "basic_str": [22, 23, 24, 25, 26], "basis_vector": 11, "basis_vector_combin": 53, "basis_vector_search": [4, 19], "basis_vector_search_strategi": 4, "basisvectorminimis": 11, "basisvectorsearch": 11, "basisvectortarget": 11, "batch": [1, 33, 44, 52, 63, 72, 73, 76, 79, 84, 88, 96], "batch_offset": [29, 33, 52], "batch_rang": 43, "batch_siz": 96, "batenburg": 97, "baxter": 95, "bbox": [3, 12], "bc": 2, "beal": 95, "beam": [1, 2, 3, 4, 6, 11, 22, 23, 24, 26, 27, 32, 33, 34, 35, 37, 38, 41, 47, 51, 52, 53, 54, 57, 58, 59, 60, 64, 68, 74, 75, 76, 77, 81, 82, 83, 84, 86, 87, 93, 94, 95, 97], "beam_centr": 23, "beam_prob": 52, "beam_restraint": 53, "beam_typ": 52, "beambas": [10, 24, 26], "beamcomparison": [24, 27], "beamfactori": [21, 27], "beamlin": [2, 4, 35, 44, 48, 78, 81, 82, 84, 85, 86, 87, 90, 95, 97], "beamstop": 73, "beaten": 97, "becaus": [2, 11, 42, 73, 74, 78, 81, 82, 83, 86, 87], "becker": 95, "becom": [1, 2, 14, 63, 76, 78, 83], "been": [1, 15, 23, 25, 29, 40, 47, 52, 53, 59, 60, 73, 74, 75, 76, 77, 81, 82, 83, 84, 85, 86, 87, 88, 96], "befor": [2, 7, 23, 35, 37, 38, 41, 53, 54, 59, 60, 63, 68, 73, 74, 75, 76, 77, 81, 82, 83, 84, 85, 86, 87, 88, 91], "beforehand": 74, "begin": [1, 2, 53, 73, 82, 86, 87], "behav": [42, 82, 86], "behavior": 84, "behaviour": [53, 59, 60, 74], "behen": 51, "bei": 83, "beilsten": [0, 84, 95], "being": [3, 6, 12, 14, 18, 25, 42, 53, 55, 59, 60, 63, 73, 74, 76, 78, 81, 82, 83, 84, 86, 87, 88, 93, 94], "belong": [37, 52, 77, 83], "below": [1, 3, 11, 35, 38, 40, 44, 47, 52, 53, 54, 59, 60, 63, 72, 73, 78, 82, 83, 84, 86, 87, 88], "benefici": [73, 87], "benefit": [0, 90, 97], "benjamin": 0, "benschoten": 95, "bergmann": 95, "berkelei": [0, 90, 92, 99], "bernoulli": 84, "bernstein": [2, 40, 84, 95], "best": [1, 2, 4, 11, 18, 40, 44, 45, 53, 59, 60, 63, 70, 72, 73, 74, 76, 81, 82, 83, 84, 85, 86, 87, 95], "best_model": 11, "best_monoclinic_beta": [11, 18, 40, 60, 69, 72, 74, 82], "best_subgroup": 18, "best_unit_cel": [33, 44, 63], "beta": [2, 18, 40, 60, 69, 72, 82, 84, 86, 87, 88], "betalactamase_sum": 86, "better": [48, 64, 73, 74, 76, 82, 83, 84, 86, 87, 93], "between": [0, 1, 2, 3, 11, 14, 15, 18, 21, 35, 37, 39, 40, 41, 44, 45, 47, 51, 52, 53, 54, 58, 59, 60, 61, 63, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 93], "bewar": 81, "beyond": [73, 82, 86, 87, 94], "bfg": [14, 18], "bh": 95, "bhowmick": 0, "bi": [82, 84, 86], "bia": [53, 59, 60], "bias": 72, "bib": [79, 84], "bibliograph": 2, "bibtex": [79, 84], "big": [74, 82, 86, 87], "billi": 0, "bin": [1, 15, 37, 38, 43, 45, 47, 48, 51, 53, 54, 60, 63, 72, 73, 74, 79, 81, 82, 83, 84, 85, 86, 87], "bin_size_fract": [53, 59, 60, 81], "binari": 92, "binning_method": [43, 72], "biol": [75, 95], "biolog": 95, "biologi": [90, 97, 98], "biomed": 90, "biosci": 73, "biostruct": [95, 97], "biotin": 80, "biotin16": 73, "biotin_p212121": 73, "biotin_p222": 73, "bit": [3, 24, 74, 76], "bitmap": 45, "bk": 95, "bl": 95, "bl32xu_group2_data": 76, "blah_": 93, "blame": 76, "blank": 75, "blend": 80, "blind": 76, "block": [14, 24, 53, 54, 59, 60, 63, 66, 76, 81, 82, 83, 86, 87, 93], "block_centr": 14, "block_siz": [12, 66, 82, 86], "block_size_unit": 12, "block_width": [53, 59, 60, 73, 75], "blockcalcul": [14, 19], "blockwis": 1, "blue": [45, 74, 82, 86, 87], "blur": [47, 51], "bn": 73, "bodi": [53, 59, 60], "bogan": 95, "bold": 72, "bolotovski": [0, 11], "bool": [4, 10, 11, 12, 14, 15, 16, 18, 21, 22, 23, 24, 25, 26, 37, 38, 40, 41, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 62, 63, 64, 65, 67, 68, 69, 70, 72], "boolean": [15, 31, 46], "boost": [0, 22, 23, 24, 25, 26, 35, 73], "boost_python": 12, "bootstrap": [9, 83], "bootstrap_cryst": 53, "border": [47, 50, 51, 53], "boston": 99, "both": [0, 2, 18, 35, 52, 53, 59, 60, 63, 70, 72, 73, 74, 78, 82, 84, 85, 86, 87], "botha": 95, "bother": 83, "bottom": [73, 74, 78, 87], "bound": [3, 11, 12, 18, 47, 50, 51, 53, 54, 66], "boundari": [82, 86], "bourenkov": 0, "bourn": 7, "boutet": 95, "box": [3, 12, 47, 53, 73, 74, 87], "bq": 73, "bracket": [40, 84], "bragg": 78, "branch": 87, "bravai": [40, 60, 74, 78, 84, 85], "bravais_setting_": 60, "bravais_setting_1": [60, 82, 86], "bravais_setting_2": [74, 82, 86], "bravais_setting_3": 86, "bravais_setting_4": 86, "bravais_setting_5": [75, 77, 85, 86], "bravais_setting_n": [82, 86], "bravais_summari": [82, 86], "bravais_t": 11, "breadth": 23, "break": [74, 93], "brehmer": 95, "brewster": [0, 95], "bricogn": [0, 11, 97], "bright": [45, 51, 73, 82, 86], "brilliant": 97, "bring": [73, 76, 83], "brookhaven": 2, "brotat": 72, "brought": 97, "browser": [71, 73, 76, 82, 84, 86], "bruhn": 73, "brunger": 95, "bst": 84, "buffer": [58, 72], "buffer_s": 58, "bug": 90, "build": [0, 9, 14, 79], "build_dial": 33, "build_up": 14, "built": 4, "bullet": 97, "buse": 2, "busi": 92, "button": [78, 82, 86, 87], "bypass": 55, "bz2": [44, 78, 85], "c": [0, 1, 2, 7, 10, 12, 14, 22, 23, 24, 25, 26, 35, 40, 53, 60, 61, 64, 66, 73, 74, 76, 77, 78, 81, 82, 84, 85, 86, 87, 88, 92, 95], "c2": [18, 40, 60, 69, 72, 74, 82, 86], "c222": 86, "c2221": 86, "c2sum_1": [86, 87], "c2sum_1_": 86, "c3h7no2": 44, "c_grid": 10, "ca": [95, 99], "calc_2d_rmsd_and_displac": 11, "calc_acentric_subgroup": 11, "calc_exp_rmsd_t": 14, "calc_n_param_from_bin": 15, "calcul": [0, 1, 2, 6, 11, 12, 14, 15, 18, 34, 35, 37, 39, 40, 41, 43, 47, 51, 53, 54, 58, 59, 60, 61, 63, 68, 72, 74, 76, 78, 82, 84, 85, 86, 87, 88, 95], "calculate_esd": 14, "calculate_gradi": 14, "calculate_new_offset": 15, "calculate_weight": 14, "calculate_weighted_mean": 33, "calero": 95, "calibr": [51, 66, 73, 74, 75, 81], "calibrate_pdb": 51, "calibrate_silv": 51, "calibrate_unit_cel": 51, "call": [2, 14, 16, 35, 40, 47, 48, 53, 54, 72, 74, 76, 82, 83, 86, 87, 96], "callback": 14, "callback_after_step": [14, 18, 82, 84, 86], "cambridg": [33, 99], "came": 74, "camera": 73, "camp": 0, "campaign": 82, "campbel": 11, "can": [1, 2, 3, 4, 7, 9, 11, 14, 16, 21, 23, 24, 33, 35, 37, 38, 40, 42, 44, 45, 47, 48, 51, 52, 53, 54, 55, 59, 60, 61, 63, 68, 69, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 91, 93, 95, 96, 97], "candid": [4, 11, 53, 82, 83, 86, 87], "candidate_basis_vector": 4, "candidate_crystal_model": 4, "candidate_orientation_matric": 11, "candidate_outlier_reject": 53, "candidate_spot": 53, "cannot": [47, 73, 74, 78, 81, 93], "canon": 25, "capabl": [48, 74, 90], "caption": 35, "captur": [82, 83, 86, 87], "carbon": 35, "care": [76, 81, 82, 83, 86, 87], "carefulli": [73, 74, 76], "careless": 78, "carragh": 73, "carri": [40, 82, 83, 86, 87], "carrier": 83, "cart": 84, "cartesian": [2, 11], "cascio": 95, "case": [1, 2, 4, 7, 11, 14, 15, 21, 23, 25, 35, 40, 47, 52, 53, 54, 59, 60, 61, 63, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96, 97], "cat": 75, "catalyst": 95, "cauchi": 18, "caus": [14, 15, 74, 77, 78, 82, 86, 87, 92, 93], "caution": 14, "cautionari": 78, "cb_op": [11, 18, 60, 73, 74, 77, 78, 82, 85, 86], "cb_op_inp_min": 18, "cbf": [3, 4, 21, 23, 25, 33, 45, 47, 48, 49, 51, 52, 55, 65, 75, 79, 81, 82, 83, 85, 86, 88, 93, 96], "cbf_handl": [21, 23, 25, 29], "cbf_handle_struct": 21, "cbflib": 33, "cc": [18, 40, 43, 72, 73, 74, 77, 78, 79, 81, 82, 84, 85, 86, 87, 88], "cc1": [1, 18, 73, 82, 84, 85, 86], "cc_": 84, "cc_against": 18, "cc_ano": [73, 82, 84, 85, 86], "cc_for": 18, "cc_half": [43, 72, 79, 84], "cc_half_fit": [43, 72], "cc_half_method": [43, 72], "cc_half_significance_level": [43, 72], "cc_n_bin": 60, "cc_pearson": [74, 82, 85, 86], "cc_ref": [43, 72], "cc_sig_fac": 18, "cc_spearman": [74, 82, 85, 86], "cc_true": 18, "cc_weight": [18, 40, 72], "ccano": 84, "ccd": [23, 42, 78, 82, 86, 87], "ccdc": 73, "cchalf": [63, 72], "cci": [9, 48], "ccp4": [0, 72, 73, 75, 76, 77, 79, 83, 84, 86, 87, 90, 95, 97, 98], "ccp4_scr": 79, "ccp4i2": 87, "ccref": [43, 72], "cctbx": [0, 1, 2, 4, 9, 11, 14, 18, 22, 24, 48, 79, 83, 95], "cctbx_bundl": 33, "cctbx_project": 48, "cc\u00bd": [18, 40, 43, 72, 73, 76, 82, 84, 86], "cd": [7, 9, 33, 48, 73, 74, 76, 79, 81, 83, 84, 91, 95], "cdot": [2, 35], "ce2": [1, 96], "ceas": 76, "cell": [2, 11, 14, 18, 22, 33, 35, 40, 41, 44, 45, 46, 47, 50, 51, 53, 54, 57, 58, 59, 60, 63, 64, 69, 70, 72, 73, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 95, 96], "center": [18, 40, 60, 69, 72, 77, 82, 86], "cento": 48, "centr": [14, 18, 23, 37, 41, 47, 51, 52, 53, 54, 57, 58, 59, 60, 64, 74, 75, 76, 80, 82, 86, 87, 94, 97], "central": [77, 79, 81], "centre_xi": 75, "centric": 84, "centroid": [3, 4, 11, 31, 41, 44, 47, 50, 51, 53, 54, 58, 59, 60, 66, 70, 78, 81, 82, 83, 85, 86, 87], "centroid_": 3, "centroid_definit": [41, 51, 54, 58], "centroid_diff_i": [62, 81], "centroid_diff_max": 62, "centroid_diff_x": [62, 81], "centroidanalysi": 14, "certain": [11, 35, 38, 53, 54, 59, 60, 63, 72, 73, 84, 88], "certainli": 53, "ceta": 73, "cgi": 48, "ch": [44, 74], "chain": [4, 77], "challeng": [0, 73, 74, 77, 78, 87, 95, 97], "chanc": [76, 82, 86, 87, 96], "chang": [1, 2, 9, 18, 24, 33, 39, 41, 51, 53, 54, 58, 60, 61, 63, 66, 72, 73, 74, 75, 76, 77, 81, 82, 85, 86, 87, 95, 96, 97], "change_basi": 24, "change_of_basis_op": [11, 18, 24, 61, 69, 74, 77, 82, 86], "change_of_basis_op_to_best_cel": [18, 19], "chapui": 2, "char": [22, 23, 24, 25, 26], "char_trait": [22, 23, 24, 25, 26], "charact": [12, 51, 52], "characteris": 81, "characteristic_grid": [11, 53], "chatterje": 95, "chdir": 83, "cheat": 74, "check": [1, 4, 7, 9, 16, 18, 24, 26, 33, 37, 38, 53, 63, 69, 74, 76, 79, 81, 82, 83, 84, 86, 93], "check_consistent_index": 63, "check_doubled_cel": [11, 53], "check_flag": 16, "check_format": [6, 24, 26, 30, 33, 83], "check_head": 26, "check_indexing_symmetri": [71, 78], "check_misindex": 53, "check_reference_geometri": 52, "checkbox": [74, 87], "checkout": 9, "checkpoint": [53, 59, 60], "chemic": 44, "cheng": 73, "chi": [53, 59, 60], "chiang": 73, "chiral": [73, 74, 82, 84, 86], "chmod": 74, "chno": [73, 88], "choi": 95, "choic": [1, 2, 15, 18, 34, 38, 39, 40, 41, 43, 44, 45, 47, 51, 52, 53, 54, 57, 58, 59, 60, 62, 63, 68, 69, 72, 73, 76, 77, 82, 84, 86, 87, 88], "choleski": 14, "chollet": 95, "choos": [2, 18, 38, 44, 53, 59, 60, 63, 72, 73, 74, 77, 81, 82, 86, 87, 89], "choose_best_orientation_matrix": 11, "chose": [75, 81, 87], "chosen": [1, 2, 4, 11, 14, 15, 18, 35, 38, 43, 53, 57, 59, 60, 62, 63, 74, 76, 77, 82, 84, 85, 86, 87], "choudhuri": 83, "chunksiz": [47, 82, 86], "cif": [2, 40, 44, 61, 63, 70, 72, 76], "cif_fil": [21, 23, 25, 29], "cif_pet": 44, "circ": 2, "circl": [2, 47, 50, 51, 73, 76, 82, 86], "circular_grid": [41, 51, 54, 58], "circumst": [29, 53, 59, 60, 93], "circumv": 78, "citat": [79, 84], "cite": 72, "cl": 4, "clabber": [74, 75, 95], "claim": [4, 74], "clarif": 7, "clark": [0, 95], "clash": 33, "class": [2, 6, 10, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 30, 31, 33, 41, 45, 47, 51, 52, 54, 55, 58, 73, 74, 75, 82, 83, 85, 86], "classifi": [15, 47], "classmethod": [4, 14, 15, 22, 31, 33], "clean": [53, 74, 81], "cleanup": 33, "clear": [2, 24, 40, 77, 78, 81, 83, 84, 87, 88, 93, 97], "clear_cach": 26, "clearli": [2, 74, 78, 81, 82, 83, 86, 87], "clibd": 79, "click": [71, 73, 74, 77, 78, 79, 80, 81, 83, 84, 85, 86, 87, 88, 91], "client": 71, "client_serv": 48, "close": [1, 14, 24, 53, 59, 60, 66, 73, 74, 75, 77, 81, 82, 83, 86, 87], "close_to_spindle_cutoff": [14, 53, 59, 60, 81], "closer": [48, 74, 81, 83], "closest": [48, 82], "cloud": 87, "clumsi": 29, "cluster": [16, 18, 38, 40, 47, 48, 54, 72, 82, 83, 84, 86, 96], "cluster_1": [40, 84, 96], "cluster_2": 96, "cluster_20": 76, "cluster_analysi": 53, "cluster_id": [40, 84, 96], "cluster_method": 72, "cm": 95, "cmd": 83, "co": [2, 35, 76, 84, 95], "coars": [53, 64], "code": [0, 2, 4, 6, 9, 51, 74, 83, 92, 95, 96], "coeffici": [18, 35, 37, 40, 60, 72, 78, 81, 82, 86, 87], "cohen": 95, "coincid": [2, 25], "col": 6, "col_select": [14, 59, 70], "colin": 86, "collabor": [0, 90, 97, 98], "collat": 35, "collect": [11, 15, 49, 66, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96, 97], "colleti": 95, "collinear": 11, "color_schem": 51, "colorama": 33, "colour": [32, 33, 45, 62, 68, 82, 86, 87], "colour_map": 68, "colour_schem": 45, "colspot": 30, "column": [1, 3, 6, 14, 33, 53, 54, 59, 60, 63, 70, 77, 78, 84, 85], "com": [9, 41, 48, 51, 54, 58, 73, 75, 79], "comb": 38, "combin": [1, 2, 11, 15, 18, 38, 40, 44, 46, 47, 51, 53, 54, 59, 60, 63, 70, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 88, 93], "combine0": 76, "combine_crystal_model": [70, 72], "combine_experi": [71, 81, 83, 93], "combine_parti": [33, 44], "combine_scan": 53, "combined_scor": 11, "come": [76, 83], "comfort": [83, 87], "command": [1, 4, 7, 9, 32, 33, 48, 52, 63, 71, 73, 74, 75, 76, 79, 80, 81, 82, 83, 85, 86, 87, 88, 91, 96], "command_lin": [33, 83], "committe": 99, "common": [2, 18, 29, 40, 63, 73, 78, 82, 84, 86, 89], "commonli": [1, 14, 74, 76, 77, 87], "commun": [2, 74, 95], "comp": [73, 82, 84, 85, 86], "compact": [2, 11, 18, 24, 44, 52, 81], "companion": [82, 86, 87], "compar": [15, 37, 38, 44, 63, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 96], "compare_beam": [24, 33], "compare_detector": [24, 33], "compare_goniomet": [24, 33], "compare_model": [38, 83], "compare_orientation_matric": [11, 71], "comparison": [2, 11, 24, 37, 38, 39, 53, 63, 81, 83], "compat": [38, 74, 78], "compens": [75, 86], "compil": [9, 48, 91], "complet": [0, 7, 14, 21, 43, 48, 53, 56, 59, 60, 63, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 93, 97], "complete_set": 26, "complex": [4, 7, 21, 23, 38, 82, 87], "compli": 44, "compliant": 75, "complic": 83, "compon": [0, 1, 2, 4, 15, 25, 40, 47, 56, 63, 76, 82, 83, 84, 86, 87], "compos": [4, 14, 15, 25, 53, 59, 60, 88], "compose_model_p": [53, 59, 60], "composit": [2, 44], "comprehens": 97, "compress": [7, 44, 45, 78], "compress_level": 45, "compris": 83, "compromis": 1, "comput": [0, 1, 2, 11, 18, 31, 39, 41, 44, 47, 51, 54, 58, 64, 67, 76, 79, 82, 84, 94, 95, 96], "computation": [1, 87, 97], "compute_background": 31, "compute_centroid": 31, "compute_delta_cchalf": [76, 84], "compute_funct": [11, 18], "compute_functional_and_gradi": [11, 14, 18], "compute_functional_gradients_and_curvatur": [14, 18], "compute_functional_gradients_diag": [14, 18], "compute_gradi": 18, "compute_gradients_fd": 18, "compute_mean_background": [16, 47], "compute_residu": 14, "compute_residuals_and_gradi": 14, "compute_restraints_functional_gradients_and_curvatur": 14, "compute_restraints_residuals_and_gradi": 14, "compute_threshold": 31, "concaten": 14, "concentr": [53, 59, 60], "concern": [2, 78], "conclud": [40, 77, 81, 82, 85, 86, 87], "concomit": 97, "concret": 14, "concurr": [14, 63], "cond": 14, "conda3": 91, "conda_bas": 9, "condit": [14, 53, 59, 60, 69, 74, 92], "conf": 48, "confid": [18, 37, 40, 73, 74, 76, 82, 84, 85, 86, 87], "config": [47, 83], "config_opt": 33, "config_refineri": 14, "config_restraint": 14, "config_spars": 14, "config_target": 14, "configdict": [4, 15], "configur": [4, 9, 14, 15, 21, 23, 33, 48, 53, 59, 60, 63, 70, 79, 81, 82, 83, 84, 86, 88], "configuration_paramet": 4, "configure_compon": [4, 15], "configure_filt": 16, "configure_modul": 33, "configure_threshold": 16, "confirm": 84, "conform": 95, "confus": [2, 84], "conjunct": [47, 54], "connect": [47, 56, 62, 84], "connected": [1, 63, 72], "consecut": [4, 15, 52, 55, 63], "consecutive_refinement_ord": [4, 15], "consequenti": 92, "conserv": 11, "consid": [37, 41, 47, 50, 51, 53, 54, 58, 74, 76, 77, 82, 84, 86, 88], "consider": [47, 77, 82, 86, 87], "consist": [1, 2, 11, 14, 18, 40, 53, 60, 61, 63, 72, 74, 76, 77, 78, 82, 83, 84, 85, 86, 87, 88, 97], "const_ref": [10, 12, 25, 26], "constant": [2, 14, 53, 54, 59, 60, 75, 88], "constant2d": 54, "constant3d": 54, "constantweightingstrategi": [14, 19], "constrain": [1, 11, 53, 59, 60, 63, 82, 86, 87], "constraint": [1, 11, 14, 53, 59, 60, 70, 74, 82, 83, 85, 86, 87, 88], "constraints_manag": 14, "construct": [4, 11, 14, 16, 21, 23, 25, 29, 30, 74, 75], "constructor": [21, 33], "consum": [73, 83], "contact": 79, "contain": [1, 3, 4, 9, 11, 14, 15, 16, 18, 24, 34, 38, 40, 44, 46, 47, 52, 53, 54, 59, 60, 61, 62, 63, 70, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 87, 96, 98], "content": [30, 33, 44, 73, 74, 82, 83, 85, 86, 87], "context": [2, 94], "contigu": [47, 93], "continu": [0, 53, 59, 60, 73, 74, 77, 78, 82, 83, 85, 86, 87, 93], "contract": [0, 90, 92], "contradict": 35, "contrari": 77, "contrast": [74, 87], "contribut": [0, 18, 53, 59, 60, 76, 83], "contributor": [0, 92], "control": [14, 38, 43, 44, 53, 54, 59, 60, 70, 74, 87, 89, 95, 97], "conveni": [1, 2, 47, 54, 63, 69, 72], "convent": [8, 22, 52, 53, 61, 64, 66, 77, 82, 88], "convention": 2, "converg": [14, 41, 51, 54, 58, 63, 81], "convergence_as_shift_over_esd": 14, "convers": 95, "convert": [2, 12, 14, 16, 21, 22, 23, 24, 25, 26, 28, 29, 30, 52, 53, 70, 73, 88], "convert_sequences_to_stil": 52, "convert_stills_to_sequ": 52, "convert_to_cambridg": [32, 33], "convinc": 78, "convolut": [47, 51], "cooper": 11, "coord": 18, "coordin": [18, 22, 23, 25, 47, 50, 51, 52], "cope": [6, 97], "copi": [0, 14, 24, 26, 50, 74, 75, 77, 81, 83, 93], "copyright": 92, "core": [0, 81, 83, 88, 95, 96], "core_paramet": 11, "corner": [47, 50, 51, 81, 82, 86, 87], "correct": [1, 2, 3, 4, 15, 18, 23, 30, 35, 44, 47, 50, 51, 52, 54, 63, 65, 72, 74, 75, 76, 77, 80, 82, 83, 84, 86, 87, 88], "corrected_integr": 81, "corrected_refin": 81, "corrected_sv_refin": 81, "correctli": [4, 7, 37, 40, 74, 88], "correl": [3, 14, 18, 37, 40, 53, 59, 60, 61, 70, 72, 74, 76, 78, 79, 81, 82, 83, 84, 86, 87, 88], "correlation_plot": [59, 70, 83], "correlationcoefficientaccumul": [18, 19], "correspond": [4, 6, 11, 14, 33, 36, 53, 54, 73, 74, 77, 78, 82, 83, 84, 86, 87], "corrplot": [70, 83], "corrplot_x": 83, "cos_angl": 72, "cosin": 44, "cost": 86, "cosym": [19, 32, 63, 71, 72, 73, 76, 84], "cosymanalysi": [18, 19], "could": [14, 29, 53, 59, 60, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93], "count": [18, 40, 66, 72, 74, 76, 78, 82, 84, 85, 86, 87, 97], "counting_sort": [43, 72], "coupl": [1, 83], "cours": [2, 82, 87, 88], "cov": 80, "covari": [53, 59, 60, 87], "cover": [1, 47, 54, 76, 82, 86, 87], "coverag": [1, 81], "cpu": [81, 83, 97], "cpv17": 95, "creat": [1, 4, 7, 9, 14, 15, 16, 22, 23, 24, 26, 28, 38, 48, 50, 53, 54, 59, 60, 63, 70, 74, 75, 76, 82, 83, 86, 87, 88, 96], "create_profile_model": [54, 71], "cred": [47, 54, 63, 66, 69, 72], "criteria": [14, 43, 46, 76, 82, 84, 86], "criterion": [14, 53, 59, 60, 63, 82, 84, 86, 87], "critic": [76, 81, 97], "croll": 74, "cross": [63, 74, 75, 82, 84, 86], "cross_valid": 63, "cross_validation_mod": 63, "crossov": [1, 81], "crucial": 36, "cryst": [0, 11, 18, 40, 64, 69, 72, 77, 79, 84], "crystal": [1, 2, 3, 4, 6, 11, 15, 18, 24, 27, 30, 32, 33, 34, 38, 40, 44, 47, 48, 52, 53, 54, 57, 59, 60, 62, 63, 65, 66, 68, 69, 70, 72, 73, 74, 75, 77, 78, 79, 80, 81, 82, 85, 86, 87, 88, 93, 95, 96], "crystal_a": 11, "crystal_b": 11, "crystal_id": [60, 85], "crystal_model": [11, 22], "crystal_nam": [33, 44, 63], "crystalbas": [22, 24], "crystalfactori": [22, 27], "crystallin": [84, 95], "crystallis": [83, 84], "crystallogr": [2, 75, 95], "crystallograph": [0, 1, 2, 70, 72, 76, 77, 82, 95], "crystallographi": [0, 1, 2, 73, 74, 90, 94, 96, 97], "crystfel": 97, "cs03r": 79, "csh": [7, 48], "ctruncat": [77, 86], "cubic": 35, "culprit": 78, "cumbersom": 76, "curl": [9, 48, 75, 91], "current": [2, 4, 7, 14, 18, 24, 33, 44, 53, 55, 59, 60, 63, 69, 75, 77, 78, 81, 83, 87, 91, 93, 94, 96, 97], "current_image_0": 15, "cursor": 87, "curtail": 11, "curv": [18, 43, 74, 78, 81], "curvatur": [14, 18, 40, 72], "curvatures_fd": 18, "cusp": 34, "custom": [4, 63], "cut": [1, 44, 53, 59, 60, 63, 74, 97], "cut_data": [63, 84], "cutoff": [1, 11, 18, 38, 40, 43, 44, 53, 54, 59, 60, 63, 72, 73, 76, 82, 84, 86, 87], "cutoff_criterion": 53, "cyan": 87, "cycl": [15, 41, 51, 53, 54, 58, 59, 63, 64, 72, 78, 81, 82, 84, 86, 87], "cyst_0": 88, "d": [0, 1, 2, 4, 11, 18, 22, 23, 25, 29, 30, 31, 40, 44, 46, 47, 50, 51, 53, 58, 63, 73, 74, 75, 78, 79, 81, 82, 83, 84, 86, 95, 97], "d55": 84, "d62": [18, 69], "d66": 0, "d67": [18, 69, 79], "d70": 11, "d74": [18, 40, 79, 84], "d76": 84, "d78": [72, 84], "d_": 81, "d_ep": 72, "d_max": [37, 41, 46, 47, 50, 51, 54, 56, 63, 72, 73, 74, 75, 82, 83, 84, 85, 86, 87], "d_min": [1, 11, 18, 33, 37, 38, 40, 41, 44, 46, 47, 48, 49, 50, 51, 53, 54, 56, 58, 63, 64, 69, 72, 73, 74, 75, 76, 82, 83, 84, 85, 86, 87, 88], "d_min_fin": 53, "d_min_method_1": 49, "d_min_method_2": 49, "d_min_start": 53, "d_min_step": [53, 82, 86], "d_rang": [1, 63, 72], "d_space": [45, 46, 47, 50, 51, 84], "d_star_toler": 53, "dai": 98, "dallakyan": 73, "dalton": 0, "damag": [1, 72, 73, 74, 78, 81, 82, 84, 86, 87, 92], "damerel": 95, "damping_valu": 14, "daniel": 0, "danni": 83, "dano": [33, 84], "daresburi": 0, "darmanin": 74, "dat": [83, 84], "data": [0, 4, 5, 7, 8, 11, 12, 14, 15, 16, 18, 24, 26, 33, 35, 40, 41, 43, 44, 47, 48, 49, 52, 53, 54, 55, 59, 60, 61, 62, 63, 66, 69, 70, 72, 77, 78, 79, 80, 81, 83, 84, 85, 89, 90, 92, 93, 94, 95, 97, 98], "data_par": 75, "datablock": [24, 75], "datafil": [1, 79, 82, 83, 85, 86], "dataset": [15, 18, 33, 40, 44, 47, 53, 54, 59, 60, 61, 63, 69, 72, 74, 76, 77, 78, 81, 82, 84, 85, 86, 87, 89, 97], "dataset_id": 33, "dataset_select": 63, "datastructur": 15, "datatyp": 14, "date": [14, 81], "datum": [2, 35], "dave": [81, 97], "david": [0, 97, 98], "dbscan": 53, "de": [0, 90, 95], "dead": [46, 81], "dead_tim": 46, "deal": [2, 75, 81, 87], "dealt": 78, "debug": [14, 44, 53, 54, 57, 59, 81, 82, 86, 87], "debug_centroid_analysi": [53, 59, 60], "dec": 95, "decad": 0, "decai": [1, 15, 63, 73, 82, 84, 86, 88], "decay_correct": [1, 63, 87], "decay_interv": [1, 63], "decay_restraint": [1, 63], "decay_term": 1, "decid": [4, 76], "decim": [44, 53, 59, 60], "decis": 2, "declar": 75, "decod": 24, "decompos": [2, 57, 62], "decomposit": [57, 62], "decompress": 14, "deconvolut": [41, 51, 54, 58], "decreas": [73, 74, 81, 82, 83, 84, 85, 86, 87], "dectri": [48, 81], "deem": 44, "deep": 81, "def": [4, 6, 83], "default": [1, 7, 11, 14, 15, 18, 24, 31, 33, 34, 35, 43, 44, 45, 48, 52, 53, 55, 59, 60, 61, 63, 64, 66, 68, 70, 72, 74, 75, 78, 79, 81, 82, 85, 86, 87, 88, 96], "defin": [2, 14, 15, 18, 43, 46, 47, 50, 51, 53, 54, 63, 73, 74, 75, 88], "define_entry_point": 4, "definit": [2, 14, 15, 21, 33, 74, 75, 78, 83], "defpix": 30, "deg": [6, 14, 21, 22, 23, 25, 29, 40, 81, 82, 83, 84, 85, 86, 87, 96], "degeneraci": 74, "degre": [1, 2, 11, 15, 23, 25, 35, 40, 41, 51, 53, 54, 58, 59, 60, 63, 66, 68, 72, 74, 77, 81, 82, 83, 84, 85, 86, 87, 88], "del_last_row": 14, "deleg": [4, 14], "delet": [14, 38, 54], "delete_integration_shoebox": 63, "delete_shoebox": [38, 54], "deliv": 90, "deliver": 95, "delpsi": 14, "delpsi_const": [14, 53, 59, 60], "delpsic": 14, "delta": [11, 14, 18, 40, 41, 51, 53, 54, 58, 63, 72, 73, 78, 82, 84, 85, 86, 87, 96], "delta_cc_half": [76, 84], "delta_cchalf": 84, "deltacchalf": [63, 72, 74], "deltapsi": 14, "demand": 87, "demonstr": [6, 76, 77, 87, 97], "dendrogram": [38, 40, 72, 83], "denomin": 18, "dens": 14, "densiti": [11, 18, 35, 53, 77], "depart": [0, 90, 94], "depend": [1, 2, 14, 35, 44, 48, 59, 62, 63, 76, 81, 82, 86, 87, 88], "depict": 83, "depont": 95, "deposit": 73, "deprec": 63, "depth": [1, 4, 23], "derefer": 26, "derek": 0, "deriv": [2, 4, 6, 14, 22, 84, 87, 88, 92], "describ": [2, 3, 7, 18, 48, 53, 59, 60, 74, 75, 77, 82, 83, 84, 85, 86, 87, 88, 95], "descript": [2, 3, 4, 7, 21, 23, 47, 63, 74, 82, 83, 86, 87, 96], "design": [0, 2, 11, 23, 25, 53, 94, 95, 97], "desir": [2, 9, 41, 63, 72, 82, 85, 86, 88], "desktop": [81, 83], "despit": [74, 78, 81, 86, 87], "dest_dir_prefix": 33, "detail": [0, 1, 3, 4, 7, 14, 48, 63, 71, 72, 74, 76, 77, 78, 80, 81, 82, 84, 85, 88], "detect": [14, 53, 59, 60, 73, 78, 82, 83, 84, 86, 97], "detector": [0, 1, 2, 3, 4, 6, 10, 11, 14, 21, 24, 26, 27, 30, 32, 38, 41, 42, 45, 46, 47, 48, 50, 51, 52, 53, 54, 55, 58, 59, 60, 63, 73, 75, 76, 78, 80, 82, 83, 84, 86, 87, 88, 90, 93, 95, 97], "detector1": [53, 59, 60], "detector_gain": 54, "detector_spac": [41, 51, 54, 58], "detectorbas": 26, "detectorcomparison": [24, 27], "detectorfactori": [23, 27], "detectornod": 23, "determin": [1, 2, 3, 4, 11, 14, 15, 18, 22, 38, 40, 44, 47, 51, 52, 53, 54, 57, 59, 60, 61, 62, 63, 69, 72, 75, 76, 78, 82, 83, 84, 86, 87, 95], "determine_auto_absorption_param": 15, "determine_esq_outlier_index_arrai": 15, "determine_outlier_index_arrai": 15, "determine_reindex_operator_against_refer": [18, 19], "detract": 76, "dev": [40, 53, 59, 60, 75, 79, 82, 84, 85, 86, 91], "dev20150903": 91, "dev20191028": 79, "develop": [2, 4, 7, 8, 47, 90, 94, 95, 97, 98], "devenish": [0, 95], "deviat": [15, 35, 40, 47, 53, 54, 60, 63, 70, 72, 74, 77, 79, 81, 82, 84, 85, 86, 93], "df": [74, 76, 82, 84, 86, 87, 88], "dg": [73, 75, 95], "dh": 78, "di": [74, 76, 82, 84, 86, 87, 88, 95], "diagnost": [77, 78], "diagon": [14, 18, 77], "dial": [2, 3, 5, 6, 8, 19, 31, 32, 33, 71, 72, 73, 74, 75, 77, 78, 80, 82, 85, 86, 87, 88, 93, 99], "dials_data": 82, "dials_dyn": 44, "dials_env": [7, 91], "dials_regress": 9, "dials_scale_user_guid": [82, 84, 86], "dials_scratch": [53, 59, 60], "dials_tutori": 79, "dialsindexerror": [11, 19], "dialsindexrefineerror": [11, 19], "diamet": 73, "diamond": [0, 35, 80, 81, 82, 83, 84, 85, 86, 87, 90, 91, 92, 98, 99], "diamond_build": 91, "diao": 95, "dict": [14, 15, 18, 21, 23, 24, 25, 26, 33], "dictat": 14, "dictionari": [4, 15, 18, 21, 22, 23, 24, 25, 28, 29, 30, 44], "did": [75, 77, 81, 83, 97], "didn": [82, 83, 86, 87], "diederich": [40, 97], "diff": 33, "diff_phil": 33, "differ": [1, 2, 4, 6, 14, 18, 33, 38, 39, 40, 42, 50, 53, 54, 63, 69, 72, 74, 75, 76, 77, 81, 82, 83, 84, 86, 87, 88, 97], "difference_rotation_matrix_axis_angl": 11, "differenti": [74, 82, 86, 87], "difficult": [11, 53, 74, 78, 81, 83, 84, 87], "difficulti": [73, 77, 78], "diffract": [2, 3, 11, 21, 35, 37, 42, 44, 45, 47, 51, 53, 54, 59, 63, 66, 69, 72, 73, 74, 75, 77, 78, 81, 82, 83, 84, 86, 87, 95, 96, 97, 98], "diffus": [94, 95], "difior": 95, "digit": 52, "dim": [14, 18], "dimens": [11, 14, 18, 23, 40, 53, 59, 60, 63, 72, 74, 76, 82, 83, 84, 86, 87], "dimension": [18, 53, 82, 86], "dimensionless": 11, "dimer": 77, "direct": [2, 3, 4, 11, 21, 23, 25, 34, 38, 44, 52, 53, 59, 60, 69, 73, 74, 76, 77, 78, 82, 84, 86, 87, 92], "direction_toler": 24, "directli": [0, 3, 48, 73, 78, 79, 81, 82, 83, 86, 87, 96], "directori": [4, 7, 9, 24, 29, 30, 44, 45, 52, 57, 60, 73, 74, 75, 76, 79, 82, 83, 84, 88, 91, 93], "dirti": 83, "disabl": [1, 14, 38, 47, 50, 51, 53, 84], "disable_parallax_correct": [47, 50, 51], "disable_unit_cell_volume_sanity_check": 53, "disablempmixin": [14, 19], "discard": 63, "disclaim": 92, "disconnect": 2, "discov": [4, 81], "discret": [53, 59, 60, 63], "discuss": [0, 76, 82, 85, 86, 87, 97], "disk": 48, "disord": 77, "dispatch": 9, "dispers": [31, 45, 47, 51, 75], "dispersion_extend": 47, "dispersion_spotfinder_threshold_ext": 31, "dispersionspotfinderthresholdext": [31, 32], "displac": [2, 11], "displai": [7, 38, 40, 45, 48, 51, 72, 75, 77, 82, 86, 87], "dispos": [76, 78], "disproportion": [82, 86, 87], "disregard": 1, "dist": [48, 75], "dist_path": 4, "distanc": [2, 11, 16, 23, 40, 51, 52, 53, 54, 59, 60, 73, 75, 81, 82, 83, 84, 85, 86], "distinct": [2, 76, 84], "distl": [49, 71], "distort": [75, 78, 82, 86, 87], "distribut": [4, 18, 53, 59, 60, 65, 75, 76, 82, 86, 87, 92, 96], "dive": 74, "diverg": [3, 21, 41, 51, 52, 54, 58, 74, 82, 85, 86, 87], "divid": [53, 59, 60, 63], "divis": 4, "divisori": 3, "djb": 74, "dk": 78, "dl": [33, 78, 79, 82, 86], "dls_sw": 79, "dmax": [17, 74, 82, 83, 85, 86], "dmin": [17, 74, 82, 83, 85, 86], "do": [1, 6, 7, 9, 11, 12, 14, 16, 21, 31, 33, 38, 41, 47, 51, 53, 54, 58, 59, 60, 63, 72, 73, 74, 75, 76, 77, 79, 82, 84, 86, 87, 88, 93, 97], "do_spars": 14, "do_stil": 14, "doak": 95, "docstr": 63, "document": [1, 54, 63, 79, 92], "doe": [2, 7, 14, 17, 36, 44, 51, 52, 53, 55, 62, 73, 74, 81, 82, 83, 84, 86, 87], "doesn": 26, "doi": [11, 47, 53, 59, 60, 75, 82], "domain": [53, 74], "domain_size_ang": 22, "domain_size_toler": 22, "domin": [82, 86, 87], "don": [1, 33, 35, 38, 71, 81, 83], "done": [3, 14, 15, 44, 46, 47, 53, 54, 57, 59, 60, 62, 68, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 93], "dose": [63, 72, 81], "dose_decai": [15, 63, 72], "dosedecai": 15, "dosedecayscalingmodel": 15, "dot": [76, 82, 86], "doubl": [4, 10, 14, 22, 23, 25, 81, 91], "doubt": 73, "down": [1, 73, 74, 77, 82, 86, 87], "download": [7, 48, 71, 73, 74, 75, 78, 82, 85, 86, 87, 91], "downstream": [44, 63, 72, 74, 75, 76, 82, 84, 85, 86, 87, 88], "dozen": 76, "dp": [78, 87, 95], "dpf3": 80, "dpf3_247398": 78, "dr": [0, 53, 59, 60, 95], "draw": 73, "drawn": 84, "drevon": 0, "driessen": [53, 59, 60], "drift": [74, 75], "driven": 87, "drmaa": [47, 54], "drop": 87, "due": [1, 14, 15, 63, 72, 73, 82, 84, 86, 87, 88], "dui": 80, "dummi": 75, "dump": [24, 32, 33], "dure": [1, 2, 4, 14, 15, 40, 41, 48, 49, 50, 51, 53, 54, 58, 59, 60, 63, 72, 73, 74, 75, 76, 77, 82, 83, 84, 85, 86, 87, 96], "dw": 95, "dx": [26, 52, 53, 59, 60, 75], "dxtbx": [3, 4, 9, 10, 11, 14, 32, 73, 75, 81, 82, 83, 85, 86, 95], "dxtbx_ed_format": [73, 75], "dxtbx_model_ext": 21, "dxtbx_name": 30, "dy": [26, 52, 53, 59, 60, 75], "dyn": 48, "dynam": [44, 45, 51, 52, 54, 58, 95], "dynamic_shadow": [45, 51, 52], "e": [1, 2, 3, 4, 6, 7, 11, 14, 15, 18, 25, 35, 40, 43, 47, 49, 52, 53, 54, 59, 60, 61, 63, 64, 66, 69, 72, 73, 74, 76, 77, 82, 83, 84, 85, 86, 87, 88, 91, 93, 95], "e1": [57, 62], "e2": [7, 57, 62], "e2_rang": [1, 63, 72], "e3": [57, 62], "e_refin": 11, "each": [1, 2, 11, 12, 14, 17, 18, 33, 35, 38, 40, 42, 47, 52, 53, 54, 59, 60, 63, 65, 66, 67, 68, 69, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96], "earli": [78, 83], "earlier": [74, 75], "eas": 14, "easi": [77, 82, 83, 86, 87], "easier": [23, 25, 74, 82, 86], "easiest": 84, "easili": [2, 4, 74], "east": 90, "easy_mp": 83, "easy_run": 83, "echo": [83, 93], "echol": [0, 95], "edg": [47, 50, 51, 53, 54, 59, 60, 73, 75, 76, 88, 97], "edit": [3, 36, 73, 81, 83, 87], "editor": [73, 74, 83], "edmand": [0, 84, 95], "edu": 18, "eec": 11, "effect": [2, 14, 35, 47, 53, 59, 60, 63, 74, 76, 81, 82, 83, 84, 86, 87], "effici": [1, 3, 14], "effort": [0, 81, 83], "eg": 95, "ehrensberg": 95, "ei": 78, "eigen": 84, "eigenvector": 84, "eiger": [48, 76], "eiger16mnov2015": 48, "eighteen": 74, "eisenberg": 95, "either": [0, 1, 2, 4, 24, 40, 44, 47, 48, 51, 52, 53, 58, 59, 60, 63, 68, 70, 73, 74, 79, 82, 86, 87, 96], "el": 95, "electron": [11, 21, 47, 52, 53, 73, 74, 75, 90, 95, 97], "element": [2, 14, 15, 18, 25, 40, 76, 78, 82, 83, 84, 86, 87], "elev": 84, "elif": 95, "elimin": [11, 68, 76], "eliminate_sys_abs": 68, "ellips": 75, "ellipsoid": [41, 51, 54, 58, 96], "ellipt": 75, "els": [1, 6, 23, 87], "elsewher": 84, "eman": [53, 59, 60], "emax": [15, 43, 63, 72], "emb": 62, "emphasi": 97, "emploi": [14, 78], "employe": 90, "empti": [24, 33, 48], "en": 18, "enabl": [0, 4, 38, 45, 51, 52, 54, 83, 84, 94, 95, 96, 97], "enantiomorph": 84, "encapsul": [21, 23, 25], "encod": 3, "encount": [78, 79, 83], "encourag": 1, "end": [2, 14, 15, 33, 46, 47, 54, 59, 63, 69, 72, 73, 74, 77, 78, 81, 82, 83, 84, 86, 87, 88, 90, 96, 98], "endeavour": 90, "endors": 92, "energi": [0, 35, 90], "enforc": [53, 74, 77, 82, 83, 86], "eng": 73, "engin": [14, 18, 40, 44, 53, 59, 60, 63, 72], "enhanc": 1, "enough": [53, 59, 60, 73, 78, 81, 83, 93], "ensur": [2, 14, 23, 26, 38, 40, 63, 74, 81, 82, 83, 86, 87, 88], "enter": [3, 7, 14, 63, 74, 87], "enthusiast": 76, "entir": [4, 47, 73, 77, 88], "entri": [2, 77], "enumer": 83, "env": [4, 83], "environ": [0, 4, 48, 75, 79, 81, 91], "eof": [52, 75, 86], "ep": [18, 53], "epilog": [6, 33], "epoch": [3, 29, 52, 82, 86], "epsilon": [11, 18, 53], "eqnarrai": 2, "equal": [16, 18, 35, 43, 47, 53, 54, 56, 59, 60, 63, 66, 72, 77, 84], "equat": [14, 40], "equip": 2, "equival": [2, 14, 15, 49, 52, 60, 63, 68, 78, 82, 84, 86, 87], "era": 97, "erf": 84, "eriksson": 95, "erko": 95, "errant": 83, "error": [1, 9, 14, 15, 18, 35, 40, 44, 52, 53, 59, 60, 63, 70, 72, 74, 75, 82, 84, 86, 87, 93], "error_model": [1, 15, 63], "error_model_group": [1, 63], "error_param": 15, "ersatz": 44, "esd": [14, 88], "especi": [11, 53, 73, 84, 86, 87], "essenc": 4, "essenti": [2, 14, 73, 76, 82, 83, 86, 87], "est_standard_dev": 4, "estim": [1, 11, 18, 40, 42, 43, 48, 49, 53, 54, 59, 60, 63, 67, 70, 72, 76, 79, 82, 84, 86, 87, 88], "estimate_gain": 71, "estimate_global_threshold": [31, 32], "estimate_resolut": [71, 72, 76, 84], "estimate_tim": 33, "et": [11, 64, 72, 73, 79, 84], "etc": [2, 18, 33, 59, 70, 76, 79, 84, 88, 96], "euclidean": 53, "euler": 39, "eval": 97, "evalccd": 44, "evalu": [11, 14, 15, 46, 53, 76, 95], "evan": [0, 11, 18, 69, 83, 95, 97, 98], "even": [1, 2, 14, 44, 74, 77, 78, 82, 83, 84, 87, 92], "evenli": 11, "event": 92, "eventu": [82, 86, 87], "ever": [53, 78, 97], "everi": [14, 38, 47, 51, 53, 54, 55, 59, 60, 63, 66, 69, 72, 76, 81, 82, 83, 86, 87], "everyth": [7, 21, 23, 25, 74, 76], "everywher": [23, 78], "evid": [73, 74, 76, 77], "evolv": 0, "ewald": [14, 53, 59, 60, 74], "ewald_proximal_volume_max": 53, "ewald_proximity_resolution_cutoff": 53, "exactli": [6, 23, 74, 78, 81], "examin": [11, 38, 54, 73], "exampl": [1, 2, 3, 4, 6, 7, 8, 21, 23, 34, 35, 36, 37, 38, 39, 41, 42, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 94, 96], "exce": [14, 52], "excel": 78, "except": [4, 11, 33, 47, 53, 59, 60, 74, 75], "excis": [53, 59, 60], "excit": 44, "excitation_error_cutoff": 44, "exclud": [1, 14, 15, 33, 44, 47, 49, 53, 54, 59, 60, 63, 66, 69, 72, 74, 76, 77, 82, 83, 84, 86], "exclude_dataset": [1, 63, 76], "exclude_imag": [1, 47, 54, 63, 69, 72, 73, 84], "exclude_images_multipl": [47, 54, 63, 66, 69, 72], "exclude_single_crystal_clust": 38, "exclus": [1, 47, 51, 54, 63, 66, 69, 72, 76, 84], "execut": [16, 74, 83], "executor": [12, 19], "executorwrapp": 12, "exemplari": 92, "exercis": [77, 78], "exhibit": 83, "exist": [0, 1, 4, 9, 15, 18, 23, 52, 72, 82, 83, 84, 86, 87, 97], "exit": [3, 83], "exocytosi": 95, "exp": [35, 47, 54, 63, 69, 72, 73, 74, 78, 81, 82, 83, 85, 86], "exp_no": 33, "expand": [2, 68, 75], "expand_to_p1": 68, "expect": [2, 7, 14, 18, 35, 44, 63, 73, 74, 75, 77, 78, 81, 82, 83, 84, 86, 87, 97], "expected_cc": 18, "expens": [14, 87], "experi": [0, 1, 2, 4, 5, 11, 12, 14, 15, 16, 17, 18, 23, 24, 30, 31, 33, 35, 36, 37, 38, 40, 41, 44, 46, 47, 50, 52, 53, 54, 55, 58, 59, 60, 61, 63, 64, 65, 66, 69, 70, 72, 73, 74, 75, 78, 81, 82, 83, 84, 85, 86, 87, 88, 90, 93, 95, 96, 97], "experienc": 78, "experiment": [2, 3, 4, 7, 11, 26, 38, 52, 53, 59, 60, 61, 63, 64, 66, 70, 74, 75, 76, 77, 82, 84, 86, 87, 88, 89, 96, 97], "experiment_data": 6, "experiment_file_object_list": 33, "experiment_identifi": 33, "experiment_list": [3, 4, 11, 27, 30, 32, 33, 83], "experiment_list_for_cryst": 11, "experiment_typ": 14, "experimentlist": [3, 4, 11, 14, 16, 24, 27, 33, 83], "experimentlistfactori": [24, 27], "experiments_": [88, 93], "experiments_0": [38, 40, 84, 88], "experiments_1": [38, 40, 81, 84, 88], "experiments_2": [40, 84, 88], "experiments_3": [40, 84, 88], "experiments_and_reflect": 83, "experiments_filenam": [38, 66], "expert": [0, 87], "expert_level": [7, 38, 40, 41, 43, 45, 46, 47, 50, 51, 52, 53, 54, 55, 57, 59, 60, 61, 62, 63, 66, 69, 70, 72, 82, 86], "explain": [40, 74, 76, 84], "explan": 9, "explicit": [2, 53, 59, 60, 82, 86, 87], "explicitli": [1, 54, 74], "explor": [2, 74, 78, 82, 84, 87, 95], "exponenti": 15, "export": [1, 18, 30, 33, 45, 63, 71, 74, 75, 81, 83, 84, 89], "export_al": 83, "export_as_json": 11, "export_bitmap": 71, "export_mtz": [32, 33, 83], "export_reflect": 11, "export_text": [32, 33], "expos": 14, "exposur": [46, 52, 82, 86, 87], "exposure_tim": [3, 29], "express": [2, 46, 88, 92], "expt": [1, 3, 6, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 88, 93, 96], "expt_path": 83, "extend": [5, 11, 24, 33, 41, 51, 54, 58, 72, 78, 81, 82, 86, 87, 94], "extens": [1, 4, 32, 41, 45, 47, 51, 54, 58, 59, 70, 74, 75, 90, 94], "extent": [1, 72, 82, 84, 86], "extern": [4, 14, 16, 62, 74, 87], "external_deltapsi": [53, 59, 60], "external_depend": 62, "external_lookup": 26, "externaldelpsiweightingstrategi": [14, 19], "externallookup": [26, 27], "externallookupitembool": [26, 27], "externallookupitemdoubl": [26, 27], "extra": [14, 30, 48, 53, 59, 60, 81, 87], "extra_filenam": 30, "extract": [11, 16, 33, 78, 82, 83, 85, 86, 87], "extract_reference_intens": [18, 19], "extractpixelsfromimag": [16, 19], "extractpixelsfromimage2dnoshoebox": [16, 19], "extractspot": [16, 19], "extractspotsparalleltask": [16, 19], "extrapol": 52, "extrapolate_scan": 52, "extrem": [53, 59, 60, 62, 78, 81, 83, 84, 95, 97], "ey": [82, 86, 87], "f": [2, 6, 18, 74, 75, 76, 82, 84, 85, 86, 87, 88], "fabl": 95, "face": [77, 81, 90], "facil": [44, 83, 84, 97], "facilit": [0, 97], "fact": [40, 74, 75, 77, 78, 81, 83], "factor": [1, 3, 14, 15, 35, 40, 53, 63, 64, 66, 72, 73, 77, 79, 81, 82, 83, 84, 85, 86, 87, 88], "factori": [4, 14, 16, 21, 23, 25, 26, 28, 29, 33, 81], "faculti": 18, "fail": [14, 53, 59, 60, 73, 74, 82, 83, 85, 86, 88, 93], "fail_on_bad_index": [41, 51, 54, 58], "failed_during_profile_fit": 46, "failed_during_summ": 46, "failur": [53, 59, 60, 72, 78], "fair": 83, "fairli": [73, 74, 75, 78, 81, 82, 86, 87], "fall": [38, 47, 50, 51, 54, 72, 74, 81, 82, 86], "falloff": [38, 43, 54, 84], "fals": [1, 4, 6, 11, 14, 15, 16, 17, 22, 23, 24, 26, 31, 33, 37, 38, 40, 41, 43, 44, 45, 46, 47, 48, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 63, 64, 65, 67, 68, 70, 72, 73, 74, 75, 82, 83], "famili": 32, "familiar": [83, 87], "familiaris": 1, "far": [76, 81, 83, 88], "fast": [23, 33, 38, 47, 50, 51, 52, 53, 59, 60, 73, 74, 75, 83, 86, 95], "fast_axi": [3, 23, 38, 52, 75, 82, 86], "fast_axis_toler": [23, 24], "fast_direct": 23, "fast_slow_beam_centr": [52, 73], "faster": [47, 50, 51, 53, 59, 60], "favour": [74, 77, 82, 86, 87], "fe": 95, "feasibl": 83, "featur": [73, 74, 75, 77, 83, 90], "feb": 95, "februari": 99, "fed": 73, "federici": 95, "feed": 83, "feedback": 49, "feel": [74, 82, 83, 86], "fel": 97, "femtosecond": [74, 95], "feng": 95, "fetch": 51, "few": [50, 53, 59, 60, 73, 74, 77, 78, 81, 83, 84, 96], "fewer": [38, 74, 96], "fft": [11, 53, 74, 82, 83, 86, 87], "fft1d": [4, 11, 53, 82, 83, 86, 96], "fft3d": [4, 11, 53, 87], "fi": 75, "field": [0, 11, 33, 87, 97], "fifth": 87, "fifti": 73, "figsiz": 11, "figur": [73, 74, 78, 81, 83], "file": [1, 4, 7, 8, 21, 23, 24, 25, 29, 30, 33, 35, 36, 37, 38, 40, 41, 42, 43, 44, 45, 46, 47, 48, 50, 51, 52, 53, 54, 55, 58, 59, 60, 61, 62, 63, 69, 70, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 91, 93, 96], "file_nam": [11, 48], "filenam": [11, 14, 16, 18, 24, 26, 29, 30, 33, 36, 38, 41, 44, 46, 47, 50, 52, 53, 54, 58, 59, 60, 61, 63, 66, 68, 69, 70, 74, 76, 83, 87, 96], "filename_object_list": 33, "filename_or_data": 16, "filename_or_non": [27, 30], "filename_prefix": 44, "filename_to_absolut": [27, 30], "filepath": 63, "fill": 45, "filter": [11, 12, 14, 15, 16, 18, 38, 40, 41, 44, 45, 46, 47, 48, 50, 51, 53, 54, 58, 63, 70, 72, 74, 75, 82, 84, 85, 86, 87], "filter_by_likelihood": 11, "filter_by_n_index": 11, "filter_by_volum": 11, "filter_doubled_cel": 11, "filter_ic": [11, 53], "filter_ice_r": [33, 44], "filter_integrated_centroid": 70, "filter_known_symmetri": 11, "filter_ob": 14, "filter_overlap": [11, 53], "filter_reflect": 71, "filter_similar_orient": 11, "filter_spot": 16, "filterrunn": [16, 19], "final": [1, 12, 14, 59, 63, 70, 72, 73, 74, 76, 81, 82, 83, 84, 86, 87, 88, 90], "final_list_of_fil": 83, "final_outlier_arrai": 15, "finalis": [12, 14], "finalize_reflect": 12, "find": [1, 4, 9, 11, 16, 24, 38, 42, 45, 47, 50, 51, 52, 53, 54, 64, 76, 77, 81, 83, 85, 91, 93], "find_basis_vector": [4, 11], "find_crystal_model": [4, 11], "find_lattic": 11, "find_matching_symmetri": 11, "find_max_cel": 11, "find_rotation_axi": 74, "find_spot": [3, 16, 48, 49, 53, 67, 71, 73, 74, 75, 76, 78, 81, 82, 83, 85, 86, 87, 88, 96], "find_spots_cli": 49, "find_spots_serv": 71, "finder": [16, 82, 86], "fine": [53, 59, 60, 74, 81, 82, 86, 87, 93, 97], "finish": [12, 33, 63, 82, 86, 87], "finit": 18, "firefox": [76, 84], "first": [1, 4, 12, 15, 18, 23, 25, 26, 34, 38, 40, 45, 46, 52, 53, 54, 56, 59, 60, 68, 70, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 95, 97], "firstli": 77, "fischetti": 95, "fit": [3, 12, 35, 41, 43, 51, 54, 58, 60, 63, 70, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 92], "fit_method": [41, 51, 54, 58], "fit_profil": 12, "fix": [2, 14, 15, 25, 35, 38, 41, 51, 52, 53, 54, 58, 59, 60, 63, 73, 74, 75, 77, 78, 79, 81, 82, 83, 86], "fix_initi": 63, "fix_initial_paramet": 15, "fix_list": [53, 59, 60, 75], "fixed_compon": 15, "fixed_rot": [3, 25, 38, 52], "fixed_rotation_matrix": 25, "fixed_rotation_toler": [24, 25], "flag": [3, 6, 14, 15, 16, 44, 46, 53, 54, 59, 60, 65, 70, 72, 82, 83, 86], "flag_express": 46, "flag_filt": 44, "flaig": 95, "flat": [12, 35, 47, 74, 82, 86, 87], "flatten": [12, 18, 33], "flatten_experi": [6, 32, 33], "flatten_reflect": [6, 32, 33], "flex": [3, 4, 11, 14, 15, 83], "flight": [16, 24, 94], "float": [4, 10, 11, 15, 18, 21, 22, 23, 25, 33, 35, 37, 38, 40, 41, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 62, 63, 64, 66, 68, 69, 70, 72], "flood_fil": 53, "floor": 2, "flueckig": 74, "flux": [21, 52, 82, 86], "fn": 11, "foadi": 83, "focu": [73, 76, 85, 90, 94], "focuss": 76, "fold": 63, "folder": [48, 76, 84, 86, 87], "follow": [0, 1, 2, 3, 6, 7, 9, 14, 18, 40, 43, 46, 48, 52, 53, 54, 64, 66, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 91, 92, 93, 96, 97], "font_siz": 68, "fontsiz": 45, "footprint": 73, "for_a_sampl": 18, "forc": [14, 16, 17, 38, 41, 44, 47, 51, 53, 54, 58, 59, 60, 73, 78, 82], "force_2d": 47, "force_stat": [17, 41, 51, 53, 54, 58, 59, 60, 73, 75], "force_static_model": [33, 44], "foreground": [31, 54, 74, 82, 85, 86], "foreground_background": 54, "foreground_foreground": 54, "foreseen": 78, "forgiv": 81, "fork": [24, 94], "form": [2, 7, 14, 30, 43, 47, 53, 54, 59, 60, 74, 76, 77, 78, 82, 83, 86, 87, 92], "formal": 97, "format": [1, 2, 3, 18, 23, 24, 26, 30, 33, 44, 45, 47, 51, 52, 54, 55, 57, 63, 69, 72, 73, 74, 75, 79, 81, 82, 83, 85, 86, 87, 88, 96, 98], "format_class": 26, "format_epilog": 33, "format_help": 33, "format_kwarg": [24, 26, 33], "formatbaseclass1": 4, "formatbaseclass2": 4, "formatbruk": 4, "formatbrukerfixedchi": 4, "formatbrukerphotonii": 4, "formatcbfminipilatu": [4, 82, 83], "formatcbfminipilatusdls6msn100": [85, 86], "formatcbfminipilatusmybeamlin": 4, "formatcbfminitimepix": 75, "formatmyclass": 4, "formatsmvcetad_tui": 73, "formatsmvtimepix_su_516x516": 74, "formatt": 33, "formatter_class": 33, "formula": [14, 18, 40, 72, 82, 84, 86], "fortran": 95, "forum": 97, "forward": [40, 54, 76], "found": [2, 4, 6, 11, 16, 40, 47, 48, 49, 52, 53, 63, 73, 74, 75, 78, 79, 81, 82, 83, 84, 85, 86, 87, 95, 96], "four": [1, 73, 76, 84, 88], "fourier": [53, 69], "fourth": 84, "fpercent": 33, "frac": [2, 35, 81, 82, 86, 87], "frac_binsize_cutoff": 14, "fraction": [2, 3, 11, 16, 21, 38, 41, 46, 47, 51, 52, 53, 54, 58, 59, 60, 72, 82, 84, 86], "fraction_index": 11, "fraction_of_bin_s": [53, 59, 60], "fractionalis": 2, "fragment": 82, "frame": [3, 11, 12, 21, 22, 23, 25, 33, 34, 35, 44, 47, 48, 54, 63, 68, 69, 72, 75, 76, 82, 86, 87, 97], "frame0": 12, "frame1": 12, "frame_hist": [12, 19], "frame_numb": 48, "frame_value_": 75, "frame_value_018": 75, "framework": [0, 2, 4, 6, 90, 95], "frank": 97, "fraser": 95, "free": [63, 72, 73, 74, 77, 79, 82, 83, 86, 90, 95, 97], "free_set_offset": 63, "free_set_percentag": 63, "freedom": [2, 40, 53, 59, 60, 72, 81], "freer_flag": 84, "freerflag": 73, "french": 84, "frequenc": [11, 53], "frequent": 7, "fresh": 87, "friedel": [73, 78, 82, 86], "from": [0, 1, 2, 3, 4, 6, 7, 9, 11, 14, 15, 16, 18, 21, 22, 23, 24, 25, 26, 29, 30, 33, 35, 38, 40, 41, 44, 45, 47, 48, 50, 51, 52, 53, 54, 55, 57, 59, 60, 61, 62, 63, 64, 66, 69, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 91, 92, 93, 94, 95, 96, 97, 98], "from_arg": 24, "from_data": [4, 15], "from_dict": [4, 15, 21, 22, 23, 24, 25, 28, 29, 31], "from_fil": [3, 24, 83], "from_filenam": 24, "from_imageset": 26, "from_imageset_and_cryst": 24, "from_json": 24, "from_json_fil": [14, 24], "from_mosflm_matrix": 22, "from_paramet": [11, 16], "from_parameters_and_experi": 14, "from_parameters_data_experi": 14, "from_parameters_reflections_experi": 14, "from_phil": [12, 21, 23, 25, 29], "from_pickle_fil": 24, "from_sequence_and_cryst": 24, "from_serialized_format": 24, "from_stills_and_cryst": 24, "from_sunbird": 48, "from_templ": [24, 26], "from_xd": 24, "front": 73, "fry": 95, "fuent": [0, 95, 98], "full": [1, 3, 4, 14, 21, 23, 74, 76, 81, 82, 83, 86, 87, 96], "full_matrix": [1, 63], "full_matrix_engin": 63, "full_matrix_max_iter": [1, 63], "fuller_kapton": 54, "fulli": [0, 2, 44, 46, 54, 74, 81, 82, 85, 86], "fully_buff": 83, "func": 83, "function": [1, 2, 7, 11, 12, 14, 15, 16, 18, 26, 36, 40, 43, 53, 54, 59, 60, 63, 74, 81, 82, 83, 84, 86, 87, 94], "fund": [0, 94], "fundament": [2, 14], "further": [0, 1, 4, 7, 15, 48, 63, 72, 77, 81, 82, 85, 86, 87, 88, 91, 96], "furthest": 84, "futur": [94, 97, 98], "g": [0, 1, 2, 3, 6, 7, 11, 14, 15, 18, 30, 40, 47, 49, 52, 53, 54, 59, 60, 61, 63, 64, 66, 69, 72, 73, 76, 77, 79, 82, 83, 84, 85, 86, 88, 91, 95], "g06727c3": 75, "g5dd0b6cbf": [], "g73f70f18": 79, "g9af1ec126": [40, 82, 84, 86], "gain": [0, 23, 26, 33, 42, 45, 47, 51, 52, 73, 74, 75, 78, 82, 86], "gain_map": [42, 47], "gaithersburg": 35, "gallo": 95, "gambin": 74, "gamma": [2, 18, 40, 84, 88], "ganesh": 73, "garib": [0, 98], "gaug": 84, "gauss": 14, "gaussian": [15, 31, 41, 47, 51, 54, 58, 82, 86, 87], "gaussian_r": [4, 31, 41, 51, 54, 58], "gaussian_rs_profile_model_ext": [4, 31], "gaussianrsprofilemodelext": [31, 32], "gaussnewton": [53, 59, 60, 63], "gaussnewtoniter": [14, 19], "gb": [79, 81, 82, 86], "gec9ae4af3": [], "gemmi": 33, "gener": [0, 1, 3, 4, 11, 12, 18, 24, 25, 29, 33, 35, 45, 46, 47, 50, 51, 52, 53, 54, 56, 57, 60, 62, 63, 66, 67, 68, 72, 74, 75, 76, 81, 82, 83, 84, 85, 86, 87, 88, 90, 94, 96, 97], "generalis": 0, "generate_distortion_map": 75, "generate_from_phil": 23, "generate_mask": [71, 73, 75], "generate_phil_scop": [12, 16, 19], "genuin": 40, "geometri": [2, 3, 4, 11, 33, 44, 52, 53, 59, 60, 66, 74, 75, 77, 80, 81, 82, 86, 87, 88, 95, 96, 98], "gerard": [0, 97], "gerstel": [0, 95], "gerstman": 18, "get": [1, 8, 14, 16, 17, 23, 24, 25, 26, 29, 30, 33, 54, 74, 76, 81, 82, 83, 84, 86, 87], "get_a_as_sqr": 22, "get_a_inverse_as_sqr": 22, "get_accepted_refs_s": 14, "get_alpha_angl": 25, "get_angl": 25, "get_angle_from_array_index": 6, "get_array_rang": [6, 26], "get_ax": 25, "get_beam": [26, 30], "get_cbf_head": 4, "get_centroid_analys": 14, "get_corrected_data": 26, "get_correlation_matrix_for_step": 14, "get_crystal_symmetri": 22, "get_data": [26, 33], "get_detector": [26, 30], "get_detectorbas": 26, "get_direct": 25, "get_domain_size_ang": 22, "get_elapsed_tim": 33, "get_entri": [32, 33], "get_experi": 14, "get_fixed_rot": [6, 25], "get_flag": 6, "get_format_class": 26, "get_free_reflect": 14, "get_gain": 26, "get_goniomet": [26, 30], "get_grid_s": 26, "get_half_mosaicity_deg": 22, "get_image_identifi": 26, "get_index": 14, "get_inverse_ub_matrix_from_xparm": [32, 33], "get_kappa_angl": 25, "get_kappa_axi": 25, "get_mask": 26, "get_master_path": 26, "get_match": 14, "get_max_inscribed_resolut": 23, "get_max_resolut": 23, "get_mosa": 22, "get_nam": [23, 25], "get_nrow": 14, "get_num_match": 14, "get_num_matches_for_experi": 14, "get_num_matches_for_panel": 14, "get_num_scan_point": 25, "get_num_step": 14, "get_ob": 14, "get_omega_angl": 25, "get_omega_axi": 25, "get_panel_intersect": 23, "get_param": 26, "get_param_report": 14, "get_parameter_correlation_matrix": 14, "get_path": 26, "get_pedest": 26, "get_phi_angl": 25, "get_phi_axi": 25, "get_process": 83, "get_raw_data": 26, "get_raw_data_from_imageset": 55, "get_ray_intersect": 23, "get_rotation_axi": 25, "get_rotation_axis_datum": [6, 25], "get_s0": 6, "get_sample_s": 14, "get_scan": [26, 30], "get_scan_axi": 25, "get_setting_rot": [6, 25], "get_setting_rotation_at_scan_point": 25, "get_shared_compon": 15, "get_space_group_type_from_xparm": [32, 33], "get_spectrum": 26, "get_templ": [26, 30, 83], "get_vendor": 26, "get_vendortyp": 26, "get_wavelength": 6, "getcwd": 83, "getlogg": 83, "gevorkov": 11, "gf37b0db7a": 79, "gf88516da7": 85, "ghani": 83, "giacovazzo": 2, "gildea": [0, 11, 18, 40, 72, 84, 95], "gingeri": 95, "ginn": 95, "github": [9, 75, 82, 84, 86, 90, 91], "githubusercont": [9, 48, 73, 75], "give": [1, 2, 7, 14, 18, 40, 45, 46, 53, 59, 60, 61, 66, 69, 72, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 96], "given": [0, 1, 2, 4, 11, 14, 15, 16, 17, 18, 22, 23, 25, 28, 30, 35, 39, 40, 41, 44, 46, 47, 49, 51, 52, 53, 54, 55, 58, 62, 63, 64, 67, 68, 69, 72, 74, 78, 82, 83, 84, 86, 87, 96], "gj": 95, "glacio": 73, "glatzel": 95, "gleb": 0, "glm": 54, "global": [47, 53, 54, 59, 60, 64, 74, 83], "global_threshold": [45, 47, 51, 75], "globular": [82, 86, 87], "gltbx": 33, "glu": 9, "gl\u00f6ckner": 95, "gm117126": [0, 90], "gmail": 79, "gmodel": 54, "gmt": 85, "gn": [63, 95], "go": [47, 54, 63, 69, 72, 73, 74, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88], "goal": [2, 90], "goe": 73, "goldschmidt": 95, "gon_kappa": 86, "gon_omega": 86, "gon_phi": 86, "gone": [82, 86, 87], "gonen": 95, "gonimomet": 2, "goniomet": [3, 4, 6, 24, 26, 27, 32, 34, 35, 38, 52, 53, 59, 60, 74, 75, 78, 82, 83, 86, 93, 95], "goniometerbas": 25, "goniometercomparison": [24, 27], "goniometerfactori": [25, 27], "goniometershadowmask": 26, "goniostat": 2, "gonz\u00e1lez": 95, "good": [11, 38, 63, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 92], "good_result": 83, "got": 83, "gov": [9, 35, 48], "gpu": 97, "grad": 18, "gradient": [14, 18, 53, 59, 60], "gradient_calculation_blocks": [14, 53, 59, 60], "gradient_cutoff": [16, 47], "gradient_threshold": 14, "graem": [0, 97, 98], "grain": [53, 59, 60], "grant": [0, 90], "graph": [53, 56, 59, 60, 73, 87], "graph_verbos": 11, "graphic": [76, 82, 86, 87], "grate": 0, "grayscal": 51, "great": [73, 77, 87], "greater": [18, 41, 47, 51, 54, 58, 63, 64, 78, 83, 96], "greatest": [11, 81], "greatli": [0, 90, 97], "green": [82, 86, 87], "grep": 83, "greyscal": 45, "grid": [1, 11, 37, 41, 49, 51, 52, 53, 54, 58, 63, 64, 78, 81, 82, 86, 87, 96], "grid_h": 37, "grid_k": 37, "grid_l": 37, "grid_method": [41, 51, 54, 58], "grid_search_scop": 53, "grid_siz": [26, 41, 51, 52, 54, 58, 62, 81], "gridsiz": 68, "grime": 95, "gross": [0, 2, 11, 95], "grossli": 78, "ground": 0, "group": [1, 2, 4, 11, 15, 18, 22, 23, 33, 37, 40, 43, 45, 46, 47, 50, 51, 52, 53, 59, 60, 61, 63, 69, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96], "group_info": 11, "group_siz": [63, 72, 74], "groups_cach": 11, "grow": [73, 76, 77], "gruen": [75, 95], "guarante": [54, 87, 88], "guenther": 95, "guess": 72, "gui": 51, "guid": [9, 63], "guidanc": 0, "gul": 95, "gwyndaf": [0, 83, 97, 98], "gz": [44, 48, 86, 88, 91], "gzip": 75, "h": [0, 2, 35, 37, 53, 61, 73, 74, 75, 77, 78, 82, 83, 84, 85, 86, 95], "h5": 48, "ha": [1, 4, 7, 11, 14, 15, 21, 23, 25, 29, 35, 40, 53, 59, 60, 73, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 90, 93, 96, 97], "had": [73, 77, 81, 82, 83, 84, 86, 87], "half": [40, 43, 53, 72, 74, 77, 79, 82, 84, 86, 87, 88], "half_dataset": [33, 43, 72], "half_mosaicity_deg": 22, "half_mosaicity_toler": 22, "hall": [81, 95], "hammerslei": 2, "han": 95, "hand": 36, "handi": 9, "handl": [2, 16, 23, 24, 25, 29, 33, 74, 75, 76, 83, 84, 85, 98], "happen": [73, 78, 82, 85, 86, 87], "happi": [82, 83, 85, 86, 87], "happili": 83, "hardli": 74, "hardwar": 0, "harmon": [1, 63, 72, 88], "harri": [0, 98], "has_dynamic_mask": 26, "has_projection_2d": 23, "has_single_file_read": 26, "hassanul": 83, "hat": 35, "hattn": [0, 95], "have": [0, 1, 2, 4, 7, 18, 25, 35, 36, 40, 42, 44, 47, 52, 53, 54, 59, 60, 63, 71, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96, 97], "hcluster": 53, "hdf5": 24, "head": [32, 33], "header": [4, 9, 23, 26, 29, 52, 73, 74, 77, 78, 83, 85], "health": [0, 90], "hear": 79, "heart": 0, "heat": 87, "heatmap": [45, 51, 62], "heavi": [0, 63, 76], "hedman": 95, "heed": 78, "height": [47, 53, 54, 59, 60, 84], "held": [0, 2], "hellmich": 95, "help": [1, 4, 6, 18, 21, 24, 29, 33, 35, 36, 37, 38, 40, 41, 42, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 68, 69, 70, 72, 73, 74, 76, 78, 81, 82, 86, 87, 88, 96, 97], "help_messag": 6, "helper": 33, "hemispher": 11, "henc": [29, 35, 82, 84], "hennessi": 73, "here": [0, 2, 6, 14, 40, 48, 52, 57, 62, 63, 71, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 93, 94, 95], "heurist": 87, "hidden": [14, 81], "hide": [40, 82, 84, 86], "hieararchy_level": 81, "hierarch": [38, 40, 53, 59, 60, 72, 81], "hierarchi": [4, 23, 52, 53, 59, 60, 75, 81], "hierarchy_level": [53, 59, 60, 81], "high": [0, 1, 11, 18, 35, 37, 38, 40, 46, 47, 48, 50, 51, 53, 54, 63, 72, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 96, 97], "higher": [1, 4, 11, 63, 73, 74, 78, 82, 83, 84, 86, 87], "highest": [1, 11, 38, 40, 54, 61, 78, 81, 82, 84, 85, 86, 87], "highli": [74, 83, 97], "highlight": [76, 87], "hilgart": 95, "hint": [73, 76, 78, 87], "hist": [12, 19], "histogram": [12, 53, 74, 76, 82, 85, 86], "histogram_bin": [11, 53], "histor": [9, 97], "histori": [14, 53, 59, 60, 84, 85, 87], "hj": 95, "hkl": [2, 17, 30, 39, 44, 68, 78, 88], "hkl_base": 84, "hkl_limit": 68, "hkl_offset": [11, 61, 78], "hkl_toler": 53, "hklf": [44, 73], "hklin": [75, 86], "hklout": [33, 44, 73, 75, 81, 83, 86, 88, 93], "hm": 95, "hodgson": 95, "hold": 2, "holder": 92, "hollenbeck": 95, "holm": 74, "holton": 95, "home": [7, 75], "hopefulli": [4, 83], "horizont": 2, "horrel": 95, "host": [48, 49, 79], "hostnam": 49, "hot": 47, "hot_mask": [16, 47], "hot_mask_prefix": [16, 47], "hour": 48, "how": [1, 4, 6, 11, 14, 15, 47, 53, 57, 59, 60, 62, 73, 74, 76, 78, 81, 82, 83, 84, 86, 87, 88, 95, 96, 97], "howev": [0, 1, 2, 14, 41, 42, 44, 54, 61, 68, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 92, 93, 96], "hp": [78, 95], "ht": 95, "html": [1, 40, 43, 48, 62, 63, 69, 73, 74, 76, 84, 85, 96], "http": [9, 11, 18, 35, 47, 48, 53, 59, 60, 73, 75, 82, 88, 91], "httpd": 48, "hu": 83, "hubbel": 35, "human": 3, "hundr": 76, "hunter": 74, "huw": 0, "hw": 95, "hybrid": 0, "hypothesi": 87, "i": [0, 1, 2, 3, 4, 6, 7, 9, 11, 14, 15, 16, 18, 21, 22, 23, 24, 25, 26, 29, 33, 34, 35, 36, 38, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 66, 68, 69, 70, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 92, 93, 94, 95, 96, 97], "i04": [82, 85, 86, 87], "i04_thaumatin": 79, "i19": 35, "i2": [18, 40, 60, 69, 72, 74, 82], "i23": 40, "i3_1_0001": 48, "i7": [81, 83], "i_mean_over_sigma_mean": [43, 72], "i_over_sigma": 54, "ian": 0, "ibg": [74, 81, 82, 85, 86], "ibrahim": 95, "ic": [44, 45, 46, 47, 49, 50, 51, 53, 54, 81, 82, 84, 86, 95], "ice_r": [45, 46, 47, 50, 51, 54], "id": [1, 3, 16, 33, 44, 46, 52, 53, 59, 60, 63, 66, 67, 72, 73, 74, 78, 82, 83, 84, 85, 86, 95], "id_": [4, 15], "idea": [0, 76], "ideal": [4, 33, 74, 77, 88, 93], "ident": [6, 40, 60, 76, 82, 86, 88, 93], "identif": [53, 59, 60], "identifi": [4, 11, 23, 24, 26, 33, 40, 42, 47, 52, 53, 54, 56, 59, 60, 63, 65, 69, 72, 76, 78, 82, 83, 84, 86, 87, 88], "identifier_typ": 52, "identify_outli": 11, "idiomat": 29, "idxref": 30, "iexp": [14, 84], "ignor": [11, 26, 33, 52, 53, 58, 59, 60, 77, 84], "ignore_shadow": 58, "ignore_trusted_rang": 23, "ignore_unhandl": [33, 52], "ignore_unknown": 26, "ih": [15, 63, 82, 84, 86], "ih_tabl": 15, "ihtabl": 15, "ii": 95, "iii": 11, "ij": 18, "illumin": [82, 84, 86, 87], "illustr": [35, 76, 97], "im": [82, 86], "imag": [1, 2, 3, 4, 6, 11, 12, 14, 15, 16, 23, 24, 26, 29, 30, 31, 33, 38, 41, 42, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 58, 59, 60, 63, 64, 65, 66, 67, 68, 69, 72, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 89, 95, 96, 97], "image1": 47, "image_": [52, 55, 65], "image_0001": 49, "image_1": 52, "image_1_": 52, "image_2": 52, "image_2_": 52, "image_fil": 4, "image_group": [63, 72, 74], "image_pedest": 73, "image_pl": 23, "image_prefix": 55, "image_rang": [3, 15, 26, 29, 33, 52, 53, 64, 66, 73, 76], "image_s": [3, 23, 52, 82, 86], "image_statist": 65, "image_view": [71, 73, 74, 75, 77, 78, 81, 82, 86, 87], "image_volum": 31, "imagebuff": 26, "imagecif": 95, "imagedoubl": 23, "imagegrid": [26, 27], "imager_00": 47, "imagesequ": [3, 26, 27], "imagesequence_from_dict": [27, 30], "imagesequence_to_dict": [27, 30], "imageset": [3, 6, 16, 24, 27, 30, 32, 36, 45, 47, 53, 54, 55, 73, 74, 82, 83, 85, 86, 87, 93], "imageset_from_anyset": 26, "imageset_from_dict": [27, 30], "imageset_index": 45, "imageset_to_dict": [27, 30], "imagesetdata": [26, 27], "imagesetfactori": [26, 27], "imagesetlazi": [26, 27], "imagin": 78, "imean": [33, 84, 85, 86], "img": [73, 74, 78, 83], "imgcif": [2, 21, 23, 25, 29], "imgcif_h": [21, 23, 25, 29], "imid": [1, 15, 63, 82, 84, 86], "immedi": [54, 75, 81, 86, 87], "impact": [2, 14, 73, 88], "imping": 54, "implement": [4, 14, 15, 16, 18, 23, 26, 31, 40, 41, 51, 54, 58, 69, 78, 84, 90, 95], "impli": [29, 53, 59, 60, 63, 78, 82, 86, 87, 92], "implicit": [2, 54], "import": [1, 2, 3, 4, 6, 7, 24, 32, 33, 42, 47, 53, 64, 67, 71, 74, 76, 77, 81, 83, 89, 96], "important_numb": 4, "importantli": 15, "impos": [75, 85], "improperli": 74, "improv": [1, 63, 73, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96], "in_beam_plan": [53, 59, 60], "in_plac": 24, "in_spindle_plan": [53, 59, 60, 73, 75], "inaccur": 78, "inadequaci": 2, "incid": [35, 53, 59, 60], "incident": 92, "includ": [0, 1, 4, 11, 14, 18, 24, 33, 43, 44, 47, 48, 49, 53, 54, 57, 59, 60, 61, 63, 70, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 90, 92], "include_bad_refer": 54, "include_gui_packag": 33, "include_unused_reflect": 59, "inclus": [14, 40, 46, 47, 53, 54, 59, 60, 63, 69, 72, 74], "incom": [1, 82, 86, 87], "incompat": 2, "incomplet": [73, 74, 75, 88], "inconsist": 53, "incorpor": [81, 98], "incorrect": [37, 53, 74, 77, 78, 88], "incorrectli": [82, 86], "increas": [7, 14, 53, 63, 72, 73, 81, 82, 83, 86, 87, 96, 97], "increasingli": 78, "increment": [18, 63, 74, 76], "inde": [74, 78, 79], "indent": [4, 18, 33], "independ": [41, 53, 59, 60, 76, 81, 82, 84, 86, 87, 88, 96], "index": [2, 3, 6, 14, 15, 17, 18, 19, 26, 32, 37, 40, 41, 44, 45, 46, 47, 51, 54, 58, 59, 60, 61, 62, 63, 64, 68, 70, 71, 72, 76, 77, 79, 81, 83, 84, 89, 93, 95], "index_assign": [7, 53], "index_error": 53, "index_magnitud": 53, "index_qu": 53, "index_reflect": 11, "indexed_1": 68, "indexed_2": 68, "indexed_experi": 11, "indexerknownorient": 11, "indic": [2, 3, 4, 11, 14, 15, 24, 26, 39, 45, 48, 49, 51, 53, 54, 56, 59, 60, 63, 68, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87], "indirect": 92, "individu": [1, 9, 40, 44, 63, 65, 68, 73, 74, 75, 76, 80, 81, 82, 84, 85, 86, 88, 93], "individual_mtz": 83, "individualist": 97, "induc": 84, "industri": 73, "inelast": [47, 74], "infil": 30, "infinit": [2, 14], "inflat": 62, "info": [11, 33, 82, 83, 84, 86], "inform": [1, 2, 7, 9, 14, 15, 18, 23, 26, 41, 44, 47, 48, 52, 53, 59, 60, 70, 72, 73, 76, 77, 82, 83, 84, 85, 86, 87, 88, 90], "infrastructur": 0, "inher": 84, "inherit": [4, 14], "ining": 38, "init": [30, 33], "initi": [1, 11, 12, 14, 15, 21, 23, 25, 29, 53, 54, 59, 60, 63, 72, 74, 75, 77, 80, 82, 83, 86, 87, 97], "initialis": [12, 14, 15, 16, 17, 18, 31, 33, 82, 84, 86], "initialise_smooth_input": 15, "initialize_reflect": 12, "inject": [26, 95], "innov": 92, "inp": [30, 44], "input": [3, 6, 7, 11, 14, 15, 16, 18, 29, 30, 31, 33, 36, 37, 38, 40, 41, 44, 46, 47, 51, 52, 53, 54, 55, 57, 59, 60, 61, 63, 64, 66, 69, 70, 72, 73, 76, 81, 82, 83, 84, 85, 86, 87, 88, 96], "input_filenam": 30, "ins": [44, 73, 88], "insensit": [47, 84], "insert": 4, "insid": [47, 76, 83], "insidi": 78, "insight": [74, 76], "inspect": [1, 4, 59, 70, 76, 78, 81, 82, 83, 85, 86], "inspir": [0, 77, 78, 84], "instal": [4, 8, 32, 33, 48, 71, 73, 75, 77, 78, 79, 80, 81, 83, 84, 85, 86, 87, 88], "install_format": [4, 73], "installer_dir": 33, "instanc": [10, 12, 14, 16, 23, 24, 25, 26, 29, 33, 76, 78], "instanti": [4, 24], "instead": [4, 43, 63, 74, 77, 78, 83, 87], "institut": [0, 35, 90], "instruciton": 44, "instruct": [9, 44, 74, 78, 87, 91, 93, 95], "instrument": [44, 81, 94], "instrument_nam": 44, "instrument_short_nam": 44, "insu6_1_mast": 48, "int": [2, 11, 12, 14, 15, 16, 18, 23, 24, 25, 26, 33, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "integ": [2, 53, 66, 83, 84, 85], "integr": [1, 3, 15, 19, 30, 32, 35, 40, 41, 44, 46, 47, 50, 51, 56, 60, 61, 62, 63, 66, 69, 70, 71, 72, 76, 77, 78, 79, 81, 83, 84, 89, 93, 94, 95, 97, 98], "integrate_all_reflect": 54, "integrated_": [75, 83, 93], "integrated_0": 96, "integrated_1": [72, 75, 88, 96], "integrated_2": [63, 72, 75, 88], "integrated_3": [75, 88], "integrated_4": [75, 88], "integrated_5": 75, "integrated_6": 75, "integrated_7": 75, "integrated_data": 33, "integrated_experi": 75, "integrated_fil": 84, "integrated_prf": 44, "integrated_sum": 44, "integrator2d": [12, 19], "integrator3d": [12, 19], "integrator3dthread": [12, 19], "integratorexecutor": [12, 19], "integratorflat3d": [12, 19], "integratorsingle2d": [12, 19], "integratorstil": [12, 19], "intellectu": 0, "intellig": 33, "intend": [7, 35, 44, 49, 53, 59], "intens": [0, 1, 3, 11, 15, 18, 33, 35, 37, 40, 43, 44, 46, 47, 49, 53, 54, 61, 63, 72, 73, 74, 77, 78, 82, 83, 84, 85, 86, 87, 88, 94, 96, 97], "intensity_choic": [1, 33, 63], "intensity_rang": [1, 63, 72], "interact": [0, 63, 74, 75, 87, 88], "interest": [2, 16, 47, 73, 81, 83], "interfac": [0, 14, 16, 18, 41, 51, 54, 58, 74, 80, 83, 87], "intermedi": [45, 54, 83], "intern": [2, 26, 59, 63, 72, 76], "internet": [51, 62], "interpret": [6, 47, 63, 73, 74, 75, 76, 78, 96], "interrupt": [47, 54, 63, 66, 69, 72, 92], "intersect": 46, "intersection_union_ratio_cutoff": 53, "interv": [1, 15, 47, 53, 54, 59, 60, 63, 66, 69, 72, 82, 86], "interval_width_degre": [53, 59, 60], "intervent": 83, "intgrat": 30, "intris": 14, "introduc": [2, 75, 76], "introductori": 80, "inv": 14, "inv_d2": 10, "invalid": [15, 50, 74, 82, 85, 86], "invalidphilerror": [32, 33], "invers": [2, 3, 14, 40, 41, 51, 54, 58, 72, 78, 82, 84, 86], "inverse_greyscal": 45, "inverse_scale_factor": [3, 15], "inverse_scale_factor_vari": 3, "inverse_ub_matrix": 33, "invert": [51, 52, 78, 82, 86], "invert_rotation_axi": 52, "investig": [15, 74, 75, 77, 82, 83, 84, 86], "invis": 95, "invit": 0, "invok": 1, "involv": [15, 35, 76], "invvar": 63, "io": [4, 82, 84, 86, 90], "iob": 84, "iotbx": 18, "ioutil": 33, "ipanel": 14, "iqr": [47, 51, 53, 54, 59, 60], "iqr_multipli": [53, 59, 60], "iri": 0, "irradi": 54, "irrespect": 82, "is_consist": 24, "is_marked_for_reject": 26, "is_scal": [4, 15], "is_similar_to": [22, 23, 25], "is_single_file_read": 26, "is_stil": 16, "isbn": 0, "isfil": 83, "isi": 94, "isigi_cutoff": [38, 54], "isigma": [43, 63, 72], "isigma_cutoff": [1, 63], "isigma_rang": [1, 63, 72], "isn": 81, "isoform": 53, "isol": 77, "isomorph": [72, 76, 83], "isotrop": [11, 18, 40, 77, 84], "issu": [14, 54, 74, 76, 77, 78, 82, 83, 84, 86, 87, 90, 93], "item": [11, 16, 33, 53, 54, 59, 60, 74, 82, 85, 86], "iter": [1, 11, 14, 16, 23, 40, 41, 51, 53, 54, 58, 59, 60, 63, 64, 72, 78, 83], "iter_levelord": 23, "iter_panel": 23, "iter_preord": 23, "its": [2, 14, 33, 35, 40, 48, 53, 59, 60, 63, 70, 72, 74, 75, 77, 82, 86, 87, 92, 94], "itself": [75, 81], "iucr": 2, "iucrj": 95, "ivanova": 95, "iwata": 83, "j": [2, 11, 18, 35, 40, 47, 53, 64, 66, 72, 74, 76, 79, 84, 85, 95], "j0": [47, 53, 64, 66], "j1": [47, 53, 64, 66], "ja": 95, "jacobian": [14, 53, 59, 60], "jacobian_condition_numb": 14, "jame": [0, 83, 98], "jan": [73, 95], "jana2020": 44, "jbluic": 95, "jd": 74, "je": 95, "jen": 83, "jenkin": 0, "jessica": 73, "jf": [73, 95], "ji": 95, "jiang": 95, "jiffi": 88, "jiggeri": 6, "jim": [0, 97], "jl": 95, "jm": [75, 95], "job": [12, 16, 47, 53, 54, 59, 60, 63, 74, 81, 82, 83, 86, 87], "job_card": 30, "joblist": [12, 19], "johan": 0, "johnson": 95, "joinpath": 4, "joint": [1, 3, 53, 59, 60, 63, 80, 81], "joint_analysi": 63, "joint_export": 83, "joint_index": [53, 82, 86], "joint_json": 67, "joint_mtz": 83, "jon": 0, "journal": [0, 14, 19, 53, 59, 60], "jp": [75, 95], "jpeg": 45, "json": [3, 11, 18, 24, 30, 34, 36, 38, 40, 43, 44, 52, 54, 59, 62, 63, 67, 68, 69, 70, 75, 76, 82, 84, 86, 96], "jul": 95, "juli": 99, "jump": [78, 86], "jun": [75, 95], "june": 99, "junk": [82, 86], "just": [4, 11, 14, 23, 25, 53, 63, 73, 74, 78, 81, 82, 83, 85, 86, 87, 96, 97], "jw": 95, "k": [0, 2, 11, 18, 37, 40, 53, 61, 75, 78, 82, 84, 85, 86, 95], "k1": [53, 59, 60], "k2": [53, 59, 60], "k3": [53, 59, 60], "kabsch": [0, 97], "kai": 97, "kaiser": 95, "kappa": [25, 52], "kappadirect": 25, "kappagoniomet": [25, 27], "kappascanaxi": 25, "kapton": 54, "kapton_2019": 54, "kapton_half_width_mm": 54, "kapton_thickness_mm": 54, "katrin": 0, "kb": [1, 4, 15, 63, 72], "kbscalingmodel": 15, "ke": 95, "keabl": 95, "keen": 78, "keep": [1, 14, 38, 43, 44, 53, 59, 60, 66, 70, 72, 73, 76, 81, 87, 97], "kei": [4, 6, 14, 18, 48, 76, 82, 83, 86, 87], "kept": [6, 53, 59, 60, 75, 76, 81], "kern": 95, "kernel": [18, 40, 47, 51, 69, 72], "kernel_normalis": 18, "kernel_s": [42, 45, 47, 51], "kevin": 0, "keyword": 31, "kg": 35, "khr": 9, "kindli": [76, 78], "kingdom": 92, "kj": 74, "knew": 74, "know": [21, 23, 25, 54, 72, 73, 74, 77, 82, 83, 84, 86, 87], "knowledg": [0, 2, 35], "known": [11, 25, 47, 53, 64, 74, 77, 78, 81, 82, 86, 87, 96], "known_axi": 25, "known_crystal_model": 11, "known_orient": [11, 83], "known_symmetri": 53, "ko": 95, "kobe": 74, "kobilka": 95, "koglin": 95, "konstantino": 83, "koroidov": 95, "kovaleva": 95, "kroon": 97, "kruse": 95, "kunstlev": [0, 2, 11, 95], "kw": 73, "kwarg": [11, 14, 16, 24, 31, 33], "kwd": 14, "l": [2, 14, 18, 37, 53, 61, 74, 75, 76, 77, 78, 82, 84, 85, 86, 88, 93, 95], "l1": 75, "l2": 75, "l_0": 35, "l_1": 35, "l_i": 35, "l_min": [11, 53], "lab": [2, 45, 51], "label": [2, 14, 43, 45, 47, 59, 68, 70, 72, 84, 85], "label_indic": 68, "labelit": [48, 78], "laboratori": [0, 11, 21, 35, 68, 74, 75, 83, 90, 92, 98], "lack": [82, 86, 87], "lactamas": [86, 87], "lai": 95, "laksmono": 95, "lambda": 35, "lamp": 95, "larg": [14, 44, 51, 53, 59, 60, 63, 70, 72, 74, 75, 76, 81, 82, 84, 86, 87, 88, 89, 96, 97], "larger": [11, 53, 54, 56, 59, 60, 78, 84], "largest": [11, 14, 38, 40, 84], "laser": [95, 97], "lassal": 95, "last": [12, 14, 53, 59, 60, 74, 83, 84], "latch": 78, "late": 77, "later": [59, 70, 73, 87, 88], "latest": [7, 14, 79], "latim": 95, "latt": 73, "latter": [74, 82, 86], "lattic": [2, 3, 11, 18, 40, 44, 53, 72, 75, 76, 78, 80, 84, 95, 96, 98], "lattice_group": [18, 40, 69, 72], "lattice_id": 18, "lattice_search": 19, "lattice_search_strategi": 4, "lattice_symmetri": 18, "lattice_symmetry_max_delta": [18, 40, 69, 72], "latticesearch": 11, "laue": [11, 18, 24, 40, 69, 72, 73, 76, 82, 84, 85, 86, 94], "laue_group": [18, 69, 72, 84], "lauegroupanalysi": [18, 19], "launch": [74, 87], "law": [82, 86], "lawrenc": [0, 90, 92], "layout": 87, "lazi": 26, "lbfg": [11, 14, 18, 63, 82, 84, 86], "lbfgs_core_param": 11, "lbfgs_termination_param": 11, "lbfgs_with_curv": [18, 19], "lbfgscurv": [14, 19, 53, 59, 60], "lbl": [9, 48], "lbnl": [0, 90], "lcl": 81, "lcv": 83, "lcy": 88, "le": [11, 18, 53, 78], "lead": [1, 53, 59, 60, 77, 78, 82, 83, 86, 87], "learn": [73, 74, 81], "learnt": 97, "least": [1, 14, 53, 59, 60, 63, 74, 82, 84, 86, 87], "leastsquarespositionalresidualwithrmsdcutoff": [14, 19], "leastsquarespositionalresidualwithrmsdcutoffspars": [14, 19], "leastsquaresstillsresidualwithrmsdcutoff": [14, 19], "leastsquaresstillsresidualwithrmsdcutoffspars": [14, 19], "leav": [74, 87], "lebedev": 77, "led": 0, "lee": 0, "left": [2, 35, 78, 87], "leginon": 73, "leginon_offset": 73, "leinweb": 0, "lemk": 95, "len": [4, 6, 75, 83], "length": [11, 14, 18, 33, 35, 53, 72, 73, 77, 81, 86], "lepag": [40, 84], "lepage_max_delta": 60, "lesli": [0, 54, 97, 98], "less": [7, 18, 40, 47, 50, 51, 53, 54, 60, 63, 69, 72, 73, 74, 77, 78, 81, 82, 83, 86, 87, 88], "lesson": 73, "let": [4, 73, 74, 76, 78, 81, 82, 83, 84, 86, 87], "level": [0, 1, 4, 12, 18, 38, 43, 45, 47, 53, 59, 60, 63, 72, 74, 81, 83, 87, 88, 96], "levenberg": [14, 82, 84, 86], "levenbergmarquardtiter": [14, 19], "levi": 2, "levmar": [53, 59, 60, 63], "li": [0, 2, 53, 59, 60], "liabil": 92, "liabl": 92, "liang": 74, "lib": 79, "libgl": 9, "librari": [8, 30, 73, 83], "libtbx": [4, 6, 11, 15, 18, 83], "libtbx_refresh": 4, "lie": [2, 77], "life": 78, "light": [0, 35, 80, 81, 82, 83, 84, 85, 86, 87, 92, 99], "like": [1, 2, 3, 4, 7, 11, 14, 26, 54, 73, 74, 76, 78, 79, 81, 82, 83, 84, 86, 87, 88], "likelihood": [18, 40, 41, 51, 54, 58, 69, 73, 76, 82, 84, 85, 86, 87], "likelihood_cutoff": [11, 53], "limit": [11, 14, 37, 40, 41, 43, 46, 47, 49, 50, 51, 53, 54, 55, 58, 63, 65, 67, 72, 73, 74, 75, 76, 79, 81, 82, 83, 84, 85, 86, 87, 88, 92, 95, 97], "limit_image_rang": 15, "limit_resolution_bi": 53, "lin": 95, "line": [1, 7, 9, 12, 33, 52, 63, 71, 73, 74, 77, 79, 80, 81, 82, 83, 86, 87, 88, 96], "linear": [11, 14, 35, 53, 54, 63, 82, 83, 86, 87], "linear2d": 54, "linear3d": 54, "linearis": 14, "linearli": [14, 63], "link": [14, 65, 88], "linkag": 53, "linux": [7, 24, 74, 79, 81, 83], "list": [4, 7, 11, 12, 14, 15, 16, 18, 24, 25, 26, 29, 30, 31, 33, 35, 38, 44, 47, 50, 52, 53, 54, 56, 59, 60, 63, 73, 74, 75, 76, 77, 78, 79, 82, 83, 84, 86, 90, 92, 93, 94, 96], "liter": 47, "littl": [23, 25, 73, 74, 75, 76, 81, 82, 86, 88], "lj": 95, "ll": [74, 81, 83, 84, 86, 87], "ll_toler": [41, 51, 54, 58], "lm": [63, 95], "lmax": [1, 63, 72], "load": [6, 16, 24, 26, 30, 32, 33, 48, 51, 63, 76, 79, 82, 83, 84, 86, 87], "load_error_model": 15, "load_imag": 16, "load_model": [24, 33, 51], "loc": 18, "loc_in_list": 33, "local": [4, 7, 45, 47, 53, 62, 74, 87, 91], "localhost": 48, "locat": [3, 18, 33, 50, 53, 59, 60, 83, 84, 86, 87], "loe": 97, "log": [1, 11, 14, 18, 33, 35, 37, 38, 40, 41, 43, 44, 47, 50, 51, 52, 53, 54, 58, 59, 60, 61, 63, 64, 69, 70, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 87, 96], "log_summari": [32, 33], "logarithm": 53, "logfil": 83, "logger": 83, "logic": 47, "login": 9, "loglinear2d": 54, "loglinear3d": 54, "lond": 95, "long": [10, 12, 14, 24, 25, 26, 63, 74, 77, 82, 86, 87, 88], "longer": [75, 81, 82, 83, 84, 85, 86], "longest": 4, "look": [3, 4, 47, 52, 53, 59, 60, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 97], "lookup": [47, 52, 53, 54, 75], "lookup_symbol": 53, "loop": [14, 76, 83], "lorentz": [82, 86, 87], "loss": [72, 92], "lot": [73, 76, 81, 85, 87], "love": 79, "lovelac": 94, "low": [1, 11, 37, 47, 50, 51, 53, 63, 72, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88], "low_memory_mean": [53, 59, 60], "low_res_spot_match": [4, 53], "lower": [11, 18, 53, 54, 59, 60, 63, 73, 81, 82, 84, 86, 87], "lower_bound": 18, "lowest": [43, 63, 74, 78, 82, 86, 87], "lowresspotmatch": 11, "lp": [3, 82, 86, 87], "lsf": [47, 54], "lstbx": 14, "lucier": 73, "luck": 73, "lui": [0, 98], "lukacik": 95, "lure": 11, "lvalu": [10, 12, 22, 23, 24, 25, 26], "lys_ed_dataset_": 75, "lys_ed_dataset_1": 75, "lys_ed_dataset_2": 75, "lys_ed_dataset_3": 75, "lys_ed_dataset_4": 75, "lys_ed_dataset_5": 75, "lys_ed_dataset_6": 75, "lys_ed_dataset_7": 75, "lysozym": 76, "lyubimov": 95, "m": [2, 11, 35, 40, 46, 73, 74, 76, 79, 82, 84, 85, 86, 87, 95, 96], "m1000": 73, "ma": [95, 99], "mac": 7, "machin": [48, 49, 96, 97], "machineri": 95, "macosx": 91, "macro": [53, 59, 64, 78, 81, 82, 86, 87], "macrocycl": [53, 59, 60, 74, 78, 81, 82, 86, 87], "macrocyl": [78, 82, 86, 87], "macromolecul": [82, 84, 86], "macromolecular": [0, 1, 70, 94, 95], "made": [1, 2, 15, 23, 33, 35, 38, 40, 53, 59, 60, 74, 82, 83, 84, 86, 87, 88], "madmergedmtzwrit": [32, 33], "magic": 4, "magic_paramet": 4, "magnif": 73, "magnitud": [2, 35, 62, 63, 78], "mahalanobi": [53, 59, 60], "mai": [0, 1, 2, 3, 4, 7, 9, 11, 12, 14, 15, 18, 34, 35, 40, 41, 42, 46, 47, 48, 49, 51, 52, 53, 54, 59, 60, 62, 63, 66, 70, 72, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 91, 92, 95, 96, 99], "main": [0, 3, 9, 14, 23, 34, 63, 71, 79, 80, 86, 96], "mainli": [53, 54, 77], "maintain": [14, 48], "major": [7, 54, 74, 78, 83, 84, 87], "make": [0, 2, 4, 9, 15, 23, 25, 45, 53, 54, 55, 59, 60, 63, 70, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 90, 93], "make_app": 33, "make_beam": 21, "make_combined_plot": 15, "make_detector": 23, "make_goniomet": 25, "make_imageset": 26, "make_kappa_goniomet": 25, "make_multi_axis_goniomet": 25, "make_polarized_beam": 21, "make_polychromatic_beam": 21, "make_scan": 29, "make_scan_from_properti": 29, "make_sequ": 26, "mald": 74, "manag": [1, 12, 14, 53, 59, 60, 63, 82, 86, 98], "mandatori": 14, "manglik": 95, "mani": [0, 2, 4, 16, 38, 40, 48, 73, 74, 76, 77, 78, 79, 82, 83, 84, 86, 87], "manifest": 78, "manner": [76, 82, 86, 87, 96], "manual": [52, 73, 74, 83, 88], "map": [11, 18, 40, 42, 45, 47, 50, 51, 62, 65, 76, 77, 78, 82, 84, 86, 87], "mar": [11, 95], "marcin": 0, "margin": [17, 41, 51, 54, 77], "mark": [47, 74, 82, 86, 87], "mark_for_reject": 26, "marker": [82, 86], "marker_s": 68, "marku": 0, "marquadt": 14, "marquardt": [14, 82, 84, 86], "mashor": 73, "mask": [3, 16, 23, 26, 31, 36, 46, 47, 50, 51, 52, 54, 66, 75, 82, 86], "mask_gener": 16, "mask_param": 51, "masker": 26, "mass": [35, 41, 51, 54, 58, 82, 86], "master": [48, 73, 75, 76], "master_path": 26, "mat": 44, "mat3": [22, 25], "mat3_doubl": 25, "match": [11, 14, 18, 29, 33, 38, 48, 53, 59, 60, 66, 74, 81, 82, 83, 86, 87, 88], "match_wavelength": [32, 33], "materi": [0, 23, 35, 52, 82, 86, 92], "math": 11, "mathbf": [2, 35], "mathew": 95, "mathsf": 2, "matplotlib": [59, 70], "matric": [2, 39, 84, 85], "matrix": [1, 6, 14, 18, 22, 39, 40, 44, 52, 53, 57, 59, 60, 62, 63, 70, 72, 74, 81, 82, 83, 85, 86, 88], "matter": [51, 88], "matthew": 0, "matur": 81, "max": [40, 41, 46, 51, 52, 53, 54, 58, 63, 64, 72, 73, 74, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 96], "max_angular_differ": 18, "max_batch_s": 38, "max_cal": [18, 40, 72], "max_cel": [19, 53, 64, 82, 86, 87], "max_cell_estim": 53, "max_cell_multipli": 11, "max_cell_volume_change_fract": [41, 51, 54, 58], "max_clust": [38, 72], "max_combin": [11, 53], "max_cycl": [63, 72], "max_delta": [11, 18, 53], "max_fre": 72, "max_height_fract": [11, 53], "max_imag": 42, "max_it": [41, 51, 54, 58], "max_iter": [14, 18, 40, 53, 59, 60, 63, 72], "max_lattic": [11, 53, 85, 96], "max_length": 33, "max_memory_usag": 54, "max_n_group": [53, 59, 60], "max_pair": 53, "max_percent_remov": [63, 72], "max_possible_wl": 33, "max_quad": 53, "max_refin": 53, "max_refl": 53, "max_reflect": [64, 65], "max_reflections_per_experi": 38, "max_sample_s": 14, "max_separ": [41, 47, 51, 54, 58, 73], "max_shift_over_esd": 14, "max_spot": 73, "max_spot_s": [16, 47, 75], "max_strong_pixel_fract": [16, 47], "max_triplet": 53, "max_vector": 53, "maxd": 16, "maxim": [53, 59, 60], "maximis": 44, "maximum": [11, 15, 16, 17, 18, 38, 40, 41, 43, 44, 46, 47, 51, 52, 53, 54, 59, 60, 63, 64, 72, 76, 82, 84, 86, 87, 88], "maximum_sample_s": [53, 54, 59, 60], "maximum_trusted_valu": 47, "mayb": 76, "mayer": 73, "mc": [74, 77, 78, 79, 82, 85, 86, 95], "mcaulei": 95, "mcd": [53, 59, 60, 82, 83, 86, 87], "mcdonagh": 95, "mcfarlan": 95, "mcgilvrai": 73, "mcphillip": 95, "mcqueen": 95, "md": 35, "me": 95, "mea": [84, 85], "mean": [2, 10, 15, 36, 42, 45, 47, 51, 53, 59, 60, 63, 72, 74, 76, 77, 81, 82, 84, 85, 86, 87], "meaning": 2, "meant": 75, "measur": [1, 2, 3, 11, 14, 60, 63, 72, 74, 76, 82, 83, 84, 85, 86, 87, 95], "mechan": [81, 83], "med": [81, 82, 83, 86, 95], "med_a": [40, 84, 96], "med_alpha": [40, 84, 96], "med_b": [40, 84, 96], "med_beta": [40, 84, 96], "med_c": [40, 84, 96], "med_gamma": [40, 84, 96], "median": [18, 40, 44, 53, 59, 60, 63, 72, 84], "median_unit_cel": [18, 19], "medic": [0, 90], "medium": [1, 63, 72, 88], "meet": [0, 90, 97, 98], "member": 26, "membran": 83, "memori": [1, 11, 14, 26, 38, 53, 54, 63, 81, 82, 86], "memread": [26, 27], "mendez": 0, "mental": 73, "mention": [84, 88], "mercado": 73, "merchant": 92, "mere": 93, "merg": [1, 33, 43, 44, 53, 55, 59, 60, 63, 72, 73, 74, 76, 83, 84, 87, 88], "merge_cbf": 71, "merge_n_imag": 55, "merge_panel_scope_extracts_by_id": [23, 27], "merged_arrai": 33, "merged_mtz": [1, 63], "mergedhalfdataset": 33, "mergedmtzwrit": [32, 33], "mess": [24, 54], "messag": [7, 33], "messagepack": 3, "messerschmidt": 95, "messi": 78, "messier": 78, "messing": 95, "met": 92, "metadata": [24, 33, 44, 52, 63, 73, 74, 75, 82, 86, 87, 96], "metal": 88, "metalloenzym": 95, "method": [0, 1, 2, 7, 11, 14, 15, 16, 18, 25, 26, 29, 40, 41, 43, 47, 49, 51, 53, 54, 58, 59, 60, 63, 64, 66, 69, 72, 73, 74, 78, 82, 83, 84, 86, 87, 95, 96], "methodologi": 97, "metr": 35, "metric": [40, 43, 53, 60, 72, 73, 74, 77, 78, 82, 83, 84, 85, 86, 87], "metric_subgroup": 18, "metric_supergroup": 11, "metrologi": [51, 80], "meyer": 2, "mh": 74, "mi": [74, 78, 81, 95], "miahnahri": 95, "michel": [0, 95], "micro": [74, 80], "microcryst": [73, 74, 95], "microfocu": 97, "micron": 90, "microscop": [73, 75], "microsecond": 95, "mid": 81, "middl": 73, "midpoint": 63, "might": [2, 4, 14, 35, 74, 77, 78, 81, 82, 83, 84, 86, 87], "milathianaki": 95, "miller": [2, 3, 18, 33, 39, 51, 53, 56, 68, 76, 77, 84, 85, 87], "miller_index": 3, "miller_indic": 11, "millimet": [82, 86], "millimetr": [3, 74], "million": 1, "mimick": 77, "min": [41, 46, 51, 52, 54, 58, 73, 74, 77, 78, 81, 82, 83, 84, 85, 86], "min_cc_half": [18, 40, 69, 72], "min_cel": [11, 53], "min_cell_volum": 53, "min_chunks": [16, 47], "min_cluster_s": 53, "min_complet": [63, 72, 76], "min_component_s": 56, "min_group": 63, "min_group_s": [53, 59, 60], "min_i_mean_over_sigma_mean": [18, 40, 69, 72], "min_ih": [63, 74], "min_isigi": [33, 44, 63, 82, 84, 86], "min_isigma": 63, "min_lattic": 53, "min_loc": [45, 47, 51], "min_multipl": [63, 72], "min_n_reflect": [41, 51, 54, 58], "min_nref_per_paramet": [53, 59, 60], "min_pair": [18, 40, 72], "min_parti": [63, 72, 82, 84, 86], "min_partition_s": 54, "min_per_area": 1, "min_per_dataset": 1, "min_pixel": 54, "min_reflect": [40, 63], "min_reflections_per_experi": 38, "min_sampl": 53, "min_sample_s": 14, "min_spot": [41, 51, 54, 58, 96], "min_spot_s": [16, 47, 49, 73, 75, 81, 82, 85, 86], "min_wl": 33, "min_zeta": [41, 51, 54, 58], "mind": 73, "mini": 4, "minicbf": 75, "minim": [14, 18, 40, 44, 72, 76, 82, 84, 86, 95, 96], "minimis": [14, 18, 39, 53, 59, 60, 63, 72, 82, 84, 86, 87, 89], "minimize_scipi": [18, 19], "minimize_scitbx_lbfg": [18, 19], "minimum": [11, 14, 17, 18, 40, 41, 43, 44, 46, 47, 51, 53, 54, 58, 59, 60, 63, 72, 76, 82, 84, 85, 86], "minimum_angular_separ": [11, 53], "minimum_number_of_reflect": [53, 59, 60], "minimum_sample_s": [53, 54, 59, 60], "miniut": 97, "minor": [7, 77], "minut": [81, 83, 84, 97], "mirror": [48, 74, 82, 84, 86, 90], "misigma": [43, 72], "misindex": [37, 53, 78], "mislead": 84, "misorient": 81, "miss": [56, 73, 74, 81, 84, 89], "misset": [2, 82, 86, 87], "missing_reflect": 71, "mitig": 11, "mitzner": 95, "mixin": 14, "mj": 95, "mkdir": [48, 73, 74, 75, 76, 81, 83, 84], "ml": [40, 73, 82, 84, 86], "ml_aniso": [18, 40, 69, 72], "ml_aniso_normalis": 18, "ml_iso": [18, 40, 69, 72], "ml_iso_normalis": 18, "mm": [3, 14, 23, 35, 47, 50, 51, 52, 53, 59, 60, 74, 78, 81, 82, 83, 85, 86, 87, 95], "mm_search_scop": [53, 64], "mmcif": [44, 70, 76], "mmm": 76, "mmtbx": 33, "mn\u2084ca": 95, "mod_python": 48, "mode": [4, 15, 18, 33, 34, 40, 52, 53, 59, 60, 61, 63, 72, 74, 75, 76, 82, 83, 86, 87], "model": [0, 3, 6, 10, 11, 12, 14, 18, 19, 26, 27, 30, 31, 32, 33, 34, 35, 36, 38, 39, 40, 41, 42, 44, 45, 47, 50, 51, 52, 53, 54, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 68, 69, 70, 72, 73, 74, 76, 77, 81, 82, 83, 84, 85, 86, 87, 88, 89, 93, 95, 96, 97], "model_evalu": 19, "model_likelihood": 11, "model_param": 15, "modelevalu": 11, "modelnam": 4, "modelrank": 11, "modelrankfilt": 11, "modelrankweight": 11, "models_1": 39, "models_2": 39, "models_with_profil": 41, "modern": 2, "modif": [55, 92], "modifi": [15, 40, 41, 47, 48, 50, 53, 64, 66, 73, 81, 82, 83, 84, 85, 86], "modpython": 48, "modul": [2, 14, 15, 18, 33, 63, 77, 79, 83, 84, 86, 87], "modular": 81, "modulation_correct": [1, 63], "modulenotfounderror": 4, "mol": 73, "molecul": 80, "molecular": [73, 74, 75, 77, 95, 98], "moment": [53, 59, 60, 81], "mono": [11, 53], "monochromat": [52, 94], "monoclin": [18, 40, 60, 69, 72, 74, 82, 86, 87], "montero": [0, 95, 98], "month": 95, "moor": 14, "moral": 78, "more": [1, 3, 4, 7, 9, 11, 18, 33, 36, 38, 46, 47, 48, 53, 54, 59, 60, 63, 66, 69, 71, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 93, 96, 97], "mori": 95, "moriarti": [0, 2], "morri": 84, "mosaic": [3, 22, 41, 51, 53, 54, 58, 74, 79, 82, 86, 96], "mosaiccrystalkabsch2010": [22, 27], "mosaiccrystalsauter2014": [22, 27], "mosaicity_max_limit": [41, 51, 54, 58], "mosaicity_toler": 22, "mosflm": [0, 2, 22, 44, 52, 54, 97], "mosflm_a_matrix": 22, "mosflm_beam_centr": 52, "most": [1, 2, 4, 7, 11, 15, 18, 33, 35, 38, 53, 54, 71, 73, 74, 76, 79, 82, 83, 84, 86, 87, 88, 96, 97], "mostli": [82, 86, 87], "motion": 95, "motiv": [63, 82, 83, 86], "motor": 2, "motorlogi": 48, "mount": [2, 35], "mous": [73, 74, 87], "move": [23, 33, 53, 59, 60, 73, 77, 81, 83, 84, 86, 87], "movement": 0, "movi": 73, "mp": [47, 53, 54, 59, 60, 73, 77, 78, 79, 82, 85, 86], "mp_chunksiz": 16, "mp_method": 16, "mp_njob": 16, "mp_nproc": 16, "mplex": 76, "mpm": 48, "mpm_prefork_modul": 48, "mpro": 80, "mpro_x0692": 82, "mr": 95, "mrc": 98, "mt": 74, "mtb": [74, 75, 95], "mtz": [1, 33, 40, 43, 44, 61, 63, 72, 73, 74, 75, 76, 79, 81, 83, 84, 85, 88, 93], "mtz_unmerg": 79, "mtzwriterbas": [32, 33], "mu": [14, 23, 35, 82, 86], "much": [0, 9, 73, 74, 78, 81, 82, 83, 84, 86, 87, 88], "mult": [73, 82, 84, 85, 86], "multi": [1, 2, 15, 16, 18, 33, 38, 40, 42, 44, 45, 48, 51, 52, 53, 54, 59, 60, 63, 72, 80, 82, 86, 87, 95], "multi_axi": 25, "multi_axis_goniometer_from_phil": 25, "multi_cryst": 84, "multi_crystal_analysi": 72, "multi_dataset": [1, 63], "multi_panel": [45, 51, 52], "multiaxisgoniomet": [25, 27], "multipl": [1, 3, 4, 11, 16, 33, 34, 36, 38, 39, 43, 45, 47, 50, 51, 52, 53, 54, 59, 60, 63, 64, 66, 68, 69, 70, 72, 73, 74, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96, 97, 98], "multiple_lattice_search": 53, "multiplex": [71, 80, 95], "multipli": [35, 41, 47, 51, 53, 54, 58, 59, 60], "multiplicities_h_0": 76, "multiplicities_k_0": 76, "multiplicities_l_0": 76, "multiprocess": [14, 24, 53, 54, 59, 60, 82, 86], "multiscal": 84, "multivari": [41, 51, 54, 58, 87], "muon": 94, "murshudov": [0, 95, 98], "must": [1, 2, 4, 7, 14, 15, 33, 36, 52, 53, 54, 59, 60, 63, 64, 66, 74, 75, 76, 82, 84, 86, 87, 92], "mutual": [2, 51], "muuss": 74, "mv": 81, "mx": [79, 82, 84, 86, 88, 97], "mx27124": 82, "my": 4, "my_format_modul": 4, "mybeamlin": 4, "mycalingmodel": 4, "myd88": [74, 80], "myeloid": 74, "myformat": 4, "mylatticesearch": 4, "mymodel_phil_str": 4, "myparam": 7, "mypath": 4, "myproject": 4, "myscalingmodel": 4, "mystrategi": 4, "mystrategy_phil_str": 4, "n": [0, 2, 3, 4, 6, 11, 18, 21, 22, 33, 35, 40, 54, 58, 72, 73, 82, 84, 85, 86, 87, 95], "n_absorption_bin": [1, 63], "n_acentr": 84, "n_bin": [15, 38, 47, 51, 54, 63, 72], "n_cycl": [41, 51, 54, 58], "n_digit": 44, "n_equat": 14, "n_group": 84, "n_index": 11, "n_indexed_cutoff": [11, 53], "n_indexed_weight": [11, 53], "n_iqr": [47, 51], "n_macro_cycl": [41, 51, 53, 54, 58, 64, 78], "n_merg": 44, "n_modulation_bin": [1, 63], "n_new_param": 15, "n_old_param": 15, "n_param": 15, "n_paramet": [14, 82, 84, 86], "n_point": [11, 53], "n_ref": 18, "n_refl": [38, 82, 84, 86], "n_refl_panel_list": 38, "n_resolution_bin": [1, 63], "n_shell": 72, "n_sigma": [41, 51, 54, 58], "n_spot": 53, "n_static_macrocycl": 59, "n_subset": 38, "n_subset_method": 38, "n_subset_split": 54, "n_trial": [53, 59, 60], "n_xtal": [40, 84, 96], "na": 74, "nakan": 0, "name": [2, 3, 4, 6, 7, 14, 15, 23, 24, 25, 26, 30, 31, 33, 35, 36, 42, 44, 45, 48, 50, 51, 52, 53, 59, 60, 62, 63, 66, 70, 78, 79, 81, 82, 84, 85, 86, 87, 88, 92], "nannenga": 95, "nano": 97, "nanoimag": 73, "nanson": 74, "narrow": [11, 47, 51, 53, 83, 87], "nass": 95, "nat": [74, 95], "nathaniel": 0, "nation": [0, 35, 90, 92], "nativ": [18, 79, 81, 84, 85], "nativig": 86, "natl": [2, 95], "natur": [53, 59, 60, 84, 86, 87, 95], "nave": 53, "navig": [82, 84, 87], "nbin": [16, 43, 63, 72], "nc": [77, 84], "ndarrai": 18, "nearest": [53, 54, 56, 66, 87], "nearest_neighbor": 11, "nearest_neighbor_percentil": [11, 53], "nearest_neighbour": [11, 53], "nearli": [11, 14, 78, 81], "neat": [78, 81], "necessari": [1, 2, 11, 15, 40, 54, 73, 75, 76, 81, 82, 86, 88, 93], "necessit": 26, "need": [1, 2, 4, 9, 14, 16, 21, 24, 25, 40, 41, 47, 51, 54, 58, 60, 63, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 91, 97], "needl": 63, "neg": [73, 75, 76, 79, 84], "neglig": [74, 82, 86, 92], "negro": 73, "neighbor": 54, "neighboranalysi": 11, "neighbour": [53, 56, 82, 86, 87], "neither": 92, "nelson": 95, "ness": 53, "nest": [4, 15, 46], "net": [18, 48, 79, 82, 87, 90], "netzcc": [40, 73, 76, 82, 84, 85, 86, 87], "neuron": 95, "neutron": [2, 52], "never": 81, "nevertheless": [2, 77, 81], "new": [0, 1, 2, 7, 9, 14, 15, 16, 23, 26, 48, 53, 59, 60, 63, 71, 73, 74, 75, 77, 78, 81, 82, 83, 84, 86, 87, 90, 91, 94, 95, 97], "new_image_0": 15, "new_image_rang": 15, "new_norm_fac": 15, "newdir": 83, "newli": [82, 86], "newton": 14, "next": [6, 40, 74, 76, 82, 84, 85, 86, 87], "nexu": [33, 42, 44], "nfold": 63, "nframe": 54, "nframes_hist": [12, 19], "ng": 95, "ni": 73, "nice": [33, 73, 74], "nicer": 81, "nichola": 0, "nick": 97, "nien": 83, "nieusma": 73, "nigel": 0, "niggli": [40, 84], "nightli": [79, 91], "nist": 35, "nj": 73, "njob": [47, 54], "nk": 95, "nn": 53, "nn_hist": 11, "nn_per_bin": [11, 53], "no_shoeboxes_2d": 16, "noauto": 72, "node": [23, 87], "nois": [42, 47, 51, 75, 82, 84, 86], "non": [11, 14, 53, 59, 60, 72, 84], "non_linear_l": 14, "non_linear_ls_mixin": 14, "none": [1, 4, 6, 10, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 29, 30, 31, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 56, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72, 74, 78, 83, 84, 96], "nonisomorph": 1, "nonumb": 2, "nor": 92, "norm": 14, "norm_fac": 15, "normal": [14, 21, 35, 38, 41, 51, 52, 53, 54, 58, 59, 60, 78, 79, 82, 86, 87], "normal_matrix": 14, "normalis": [1, 15, 18, 35, 37, 40, 43, 63, 69, 72, 82, 84, 86], "normalise_bin": 37, "normdevoutlierreject": 15, "notabl": 81, "note": [14, 35, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 91, 96], "noth": [25, 52, 74], "notic": [77, 81, 82, 86, 87, 92], "notwithstand": [2, 78, 81], "novemb": 99, "now": [4, 6, 33, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 93], "np": 18, "nproc": [1, 14, 16, 18, 40, 47, 49, 53, 54, 59, 60, 63, 64, 72, 73, 82, 83, 86], "nref": [73, 74, 78, 81, 82, 83, 84, 85, 86, 87], "nref_per_degre": 14, "nsigma": 54, "nsigma_": [45, 51], "nsigma_b": [45, 51], "ntry": 73, "null": [31, 53, 54, 59, 60, 81, 83], "null_background_ext": 31, "nullbackgroundext": [31, 32], "nullify_all_single_file_reader_format_inst": 24, "num": [82, 83, 85, 86], "num_reflect": 12, "num_scan_point": 25, "number": [1, 2, 4, 7, 11, 12, 14, 15, 16, 17, 18, 33, 37, 38, 40, 41, 43, 44, 45, 47, 48, 49, 51, 52, 53, 54, 55, 58, 59, 60, 63, 64, 65, 66, 67, 69, 70, 72, 73, 74, 76, 78, 81, 82, 83, 84, 85, 86, 87, 88, 90, 95, 96], "number_of_partit": 54, "numer": [0, 1, 14, 18], "nx": [44, 47], "nxmx": 44, "ny": 47, "o": [0, 2, 4, 22, 73, 75, 79, 83, 91, 95], "oa": 95, "ob": [73, 82, 84, 85, 86, 95], "obj": [4, 15, 24, 28], "object": [2, 10, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 30, 31, 33, 52, 53, 59, 60, 66, 81, 83, 97, 98], "objective_onli": 14, "obliqu": [18, 40, 60, 69, 72], "observ": [11, 14, 16, 18, 35, 40, 41, 44, 53, 59, 60, 62, 65, 66, 69, 74, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88], "obtain": [1, 2, 4, 9, 14, 15, 40, 53, 59, 60, 75, 77, 78, 82, 84, 95], "obviou": [75, 82, 83, 86], "obvious": 6, "oc": [77, 78, 79, 85, 86], "occas": [41, 76], "occur": [74, 75, 82, 86, 87], "oct": 95, "octob": 99, "odd": 77, "off": [1, 18, 53, 54, 59, 60, 63, 73, 74, 78, 82, 83, 86, 87], "offer": [78, 97], "offset": [11, 15, 23, 52, 53, 63, 64, 74, 78, 81, 82, 86], "offsetparallaxcorrectedpxmmstrategi": 52, "often": [1, 2, 4, 11, 35, 53, 74], "ogata": 95, "ok": [79, 87, 88], "okai": [73, 74, 83], "old": 78, "old_test_flag_valu": 72, "older": [42, 87], "oliv": 0, "omega": [2, 25, 52], "omit": [82, 86], "onc": [7, 40, 47, 52, 53, 73, 74, 76, 81, 82, 85, 86, 87, 88], "one": [1, 2, 6, 11, 14, 15, 16, 24, 36, 38, 40, 44, 47, 53, 54, 59, 60, 61, 63, 69, 70, 72, 73, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96], "one_osc_width": 15, "ones": 73, "ongo": [83, 97], "onli": [1, 2, 6, 7, 11, 14, 18, 26, 33, 36, 38, 44, 45, 46, 47, 53, 54, 55, 56, 59, 60, 63, 69, 70, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96], "onlin": [35, 74, 75], "only_save_target": 63, "only_target": [1, 63], "ons": 33, "onto": [11, 53, 77, 78], "onward": 77, "ooooooooooooooooooooooooooooooooooooooooooooooooooooooooooo": 79, "oooooooooooooooooooooooooooooooooooooooooooooooooooooooooooo": 79, "op": [18, 73, 77, 78, 79, 82, 85, 86, 88], "open": [0, 3, 51, 71, 73, 74, 76, 82, 84, 86, 87, 91], "oper": [2, 4, 14, 18, 24, 37, 39, 40, 46, 47, 48, 60, 61, 73, 74, 76, 77, 78, 81, 82, 84, 85, 86, 87, 88], "oppos": 63, "opposite_of_grad_object": 14, "optic": 97, "optim": [1, 18, 74, 82, 84, 86, 87, 95], "optimis": [11, 63, 64, 72, 73, 74, 78, 82, 84, 86, 87], "optimise_basis_vector": 11, "optimise_initial_basis_vector": 53, "option": [3, 4, 6, 7, 11, 15, 18, 33, 34, 38, 39, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 57, 59, 60, 61, 62, 63, 66, 67, 68, 69, 70, 72, 74, 76, 77, 81, 82, 83, 84, 85, 86, 87, 88, 89, 93, 96], "optionpars": [32, 33], "orang": 73, "order": [1, 4, 9, 11, 14, 15, 23, 33, 36, 38, 52, 53, 54, 55, 59, 60, 63, 74, 78, 81, 82, 83, 84, 86, 87, 88], "org": [11, 18, 47, 48, 53, 59, 60, 75, 82, 88], "organ": [73, 88], "organis": [76, 99], "orient": [11, 35, 39, 41, 51, 53, 54, 57, 58, 59, 60, 62, 72, 73, 75, 81, 82, 86, 87, 88, 95, 96, 97], "orientation_decomposit": [57, 62], "origin": [2, 3, 4, 23, 38, 46, 52, 53, 64, 66, 72, 74, 75, 76, 78, 79, 82, 83, 86, 87, 94], "origin_toler": [23, 24], "orthogon": [2, 35, 53, 59, 60], "orthonorm": 2, "orthorhomb": [73, 75, 77, 78], "osc_rang": 15, "osc_start": 29, "osc_width": 29, "oscil": [1, 3, 12, 15, 29, 38, 52, 53, 59, 60, 63, 75, 77, 82, 86], "other": [2, 4, 7, 14, 22, 23, 25, 38, 40, 42, 47, 53, 54, 59, 60, 63, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 90, 92, 93, 96, 97], "other_crystal_model": 11, "otherwis": [14, 21, 46, 47, 50, 51, 53, 59, 60, 64, 74, 75, 81, 82, 86, 87, 92], "our": [0, 2, 4, 74, 81, 82, 83, 86, 87, 88, 93, 98], "out": [4, 7, 9, 14, 22, 33, 38, 44, 46, 47, 50, 51, 53, 59, 60, 73, 74, 75, 78, 81, 82, 83, 84, 86, 87, 92], "out_beam_plan": [53, 59, 60], "out_spindle_plan": [53, 59, 60, 73, 75], "outer": [43, 48, 72, 81, 88], "outgo": 1, "outlier": [1, 14, 15, 40, 53, 54, 59, 60, 63, 72, 73, 76, 81, 82, 83, 84, 85, 86, 87], "outlier_detector": 14, "outlier_in_sc": 15, "outlier_index_arrai": 15, "outlier_prob": [41, 51, 54, 58], "outlier_reject": [19, 63, 72], "outlier_zmax": [63, 87], "outlierrejectionbas": 15, "outlin": [75, 78, 82, 86], "outofsequencefil": 75, "output": [1, 3, 6, 7, 14, 33, 34, 35, 36, 37, 38, 40, 41, 42, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 69, 70, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 87, 96], "output_unintegrated_reflect": 54, "outright": 78, "outset": 76, "outsid": [2, 14, 38, 66], "outward": [76, 78], "over": [0, 1, 11, 16, 18, 40, 52, 53, 59, 60, 69, 72, 73, 74, 76, 81, 82, 84, 86, 87], "overal": [18, 40, 41, 44, 51, 53, 54, 58, 59, 60, 72, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 96], "overbias": 63, "overinfl": 1, "overlai": 74, "overlaid": 51, "overlap": [46, 53, 74, 82, 86, 87, 88], "overlaps_bord": [11, 53], "overlaps_filt": 54, "overload": [14, 74, 79, 81, 82, 84, 85, 86], "overparameteris": [1, 84], "overrid": [4, 14, 18, 41, 43, 45, 47, 51, 52, 53, 54, 58, 59, 60, 66, 72, 75, 81, 83], "overridden": [14, 52], "overview": 1, "overwrit": [23, 25, 38, 52, 81, 84], "overwrite_existing_model": 63, "overwrite_from_phil": 23, "overwritten": 74, "owen": 95, "own": [0, 4, 53, 59, 60, 63, 74, 75, 76, 83], "owner": 92, "oxford": 2, "oxid": 95, "p": [0, 2, 3, 11, 18, 40, 48, 69, 70, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96], "p1": [18, 22, 53, 73, 74, 76, 82, 86, 96], "p1_model": 83, "p2": [73, 82, 86], "p21": [73, 86], "p21212": 73, "p212121": 73, "p22121": 85, "p222": [73, 85, 88], "p2221": 73, "p4": [76, 81, 96], "p41212": 84, "p43212": [53, 76], "p4p": [70, 76, 88], "p6m": 81, "p6m_60_panel": 81, "p_cc_given_": 18, "p_cc_given_not_": 18, "p_s_given_cc": 18, "paciorek": 2, "packag": [0, 2, 4, 9, 91, 95, 97], "packed_u_accessor": 14, "pad": [17, 23, 41, 45, 51, 54, 81], "page": [11, 18, 48, 53, 73, 74, 78, 79], "pai": [74, 76, 87], "pair": [1, 2, 14, 18, 23, 34, 40, 43, 48, 53, 55, 63, 66, 72, 73, 75, 76, 78, 82, 84, 86], "pairwis": [11, 39, 40, 72, 76], "palei": 0, "panel": [3, 14, 23, 38, 45, 46, 47, 50, 51, 52, 53, 54, 55, 59, 60, 73, 74, 75, 76, 81, 82, 86, 87], "panel_param": 23, "paper": [74, 75, 95], "parallax": [47, 50, 51, 52], "parallax_correct": 52, "parallaxcorrectedpxmmstrategi": [3, 82, 86], "parallel": [1, 2, 16, 24, 35, 38, 48, 81, 82, 83, 86, 87, 95, 97], "parallel_map": 83, "parallelepip": [53, 59, 60], "param": [4, 6, 11, 12, 14, 15, 16, 18, 21, 22, 23, 25, 26, 29, 30, 31, 33, 54, 83], "param_report": 14, "paramet": [1, 2, 4, 11, 12, 14, 15, 16, 17, 18, 19, 21, 22, 23, 24, 25, 26, 29, 30, 31, 33, 73, 74, 75, 81, 82, 83, 84, 85, 86, 87, 88, 96], "parameter_correlation_plot": 14, "parameter_esd": 4, "parameter_t": 59, "parameter_valu": 63, "parameter_vector_norm": 14, "parameteris": [1, 2, 14, 15, 53, 59, 60, 73, 74, 75, 81, 82, 83, 86, 96], "parameterreport": 14, "parameters_dict": [4, 15], "parametr": 98, "parent": [75, 87], "parenthes": 46, "pari": 11, "park": 95, "parkhurst": [0, 11, 75, 95, 98], "pars": [4, 6, 33], "parse_arg": [6, 33], "parse_known_arg": 33, "parser": [6, 33], "part": [1, 2, 14, 47, 53, 59, 60, 73, 74, 80, 81, 82, 83, 84, 86, 87, 96], "parti": [0, 9], "partial": [1, 3, 18, 40, 44, 46, 53, 59, 60, 63, 69, 70, 72, 74, 77, 81, 82, 84, 85, 86, 95], "partial_data": 26, "partial_set": 26, "partiality_cutoff": [44, 63, 72, 82, 84, 86], "partiality_threshold": [1, 33, 40, 44, 69, 70], "particular": [2, 4, 26, 47, 53, 59, 60, 74, 76, 87, 92, 96], "particularli": [47, 74, 75, 78, 83, 84, 87, 88, 96], "pascal": 95, "pass": [6, 7, 14, 18, 23, 44, 45, 46, 49, 51, 52, 63, 74, 76, 77, 81, 82, 83, 84, 85, 86, 88], "passag": 35, "past": [38, 54, 74, 81], "patch": 7, "paterson": 95, "path": [1, 4, 7, 26, 34, 35, 36, 37, 40, 43, 44, 45, 47, 48, 49, 50, 51, 52, 53, 54, 55, 59, 60, 61, 62, 63, 64, 67, 68, 69, 72, 74, 81, 83, 84, 91], "pathlib": 4, "patholog": 84, "pathologi": 72, "pattern": [37, 73, 75, 77, 78, 81, 82, 83, 84, 86, 95, 97], "patterson": [18, 40, 73, 76, 82, 84, 85, 86, 87, 95], "patterson_group": 18, "paus": 78, "pb": [47, 54], "pcm": 82, "pd": 95, "pdb": [2, 40, 44, 51, 61, 63, 72, 74, 77, 82, 84], "pdb_version": 44, "pdf": [18, 53, 57, 59, 60, 71], "peachi": 25, "peak": [11, 47, 51, 53, 74, 82, 85, 86, 87, 94], "peak_search": 53, "peak_volume_cutoff": [11, 53], "peakcentroiddistancefilt": [16, 19], "peakfind": 47, "pearson": 18, "pearson_correlation_coeffici": 18, "peculiar": 75, "pedest": [23, 26, 52, 82, 86], "penros": 14, "peptid": 95, "per": [1, 14, 15, 24, 35, 36, 38, 40, 41, 43, 47, 51, 53, 54, 58, 59, 60, 63, 67, 72, 73, 74, 76, 79, 82, 83, 85, 86, 87, 93, 96], "per_degre": [41, 51, 54, 58], "per_imag": [14, 67], "per_image_statist": 47, "per_width": 14, "percent": [33, 53, 77], "percent_bandwidth": 53, "percentag": [33, 54, 63, 72], "percentil": [11, 53], "perfectli": 35, "perform": [0, 2, 6, 9, 11, 14, 15, 18, 37, 40, 41, 43, 44, 53, 54, 56, 59, 60, 63, 68, 72, 73, 74, 78, 81, 82, 83, 84, 85, 86, 87, 88, 90, 96], "perhap": [1, 44, 78], "period": [4, 11, 82, 86, 87], "perl": 83, "permiss": [7, 54, 92], "permit": 92, "pernici": 78, "perpendicular": [34, 68, 76], "perraki": 97, "perspect": [88, 97], "pet": 44, "peter": 95, "pflugrath": [0, 97], "pfuetzner": 95, "ph": 95, "pharmaceut": 73, "phase": [11, 73, 77], "phaser": 73, "phenix": 72, "phi": [2, 14, 22, 25, 52, 53, 59, 60, 63, 68, 75, 78, 81, 82, 83, 86, 87], "phi_angl": 68, "phic": [81, 82, 83, 86], "phil": [0, 3, 4, 6, 7, 11, 12, 14, 15, 18, 21, 23, 25, 29, 31, 33, 51, 54, 63, 74, 75, 83, 98], "phil_help": 11, "phil_scop": [4, 6, 11, 15, 83], "philcommandpars": [32, 33], "philo": 95, "philosophi": 0, "phio": [81, 82, 83, 86], "photon": [74, 95, 97], "photosynthet": 95, "photosystem": 95, "physic": [1, 2, 4, 15, 35, 63, 72, 82, 84, 86, 87, 88, 95, 97], "physicalscalingmodel": 15, "pick": [74, 75, 77, 87], "pickl": [11, 16, 24, 38, 47, 51, 75], "pictur": 73, "pierr": 83, "pilatu": [4, 48, 78, 81, 82, 86, 87], "pim": [76, 84, 85], "pink": [11, 82, 86], "pink_index": 53, "pinkindex": 11, "pipelin": [77, 79, 82, 84, 86, 95], "pixel": [2, 3, 16, 23, 31, 36, 41, 42, 45, 47, 50, 51, 52, 53, 54, 59, 60, 62, 73, 74, 78, 79, 81, 82, 85, 86, 87, 90, 96, 97], "pixel_label": 16, "pixel_list_to_reflection_t": [16, 19], "pixel_list_to_shoebox": [16, 19], "pixel_s": [3, 23, 52, 74, 82, 86], "pixellistlabel": 16, "pixels1": 36, "pixels2": 36, "pixels_per_bin": 62, "pkg": 91, "pkg_resourc": 4, "pkg_util": 4, "place": [14, 24, 34, 44, 52, 73, 75, 77, 81, 82, 86], "plai": [74, 82, 86], "plan": 94, "plane": [2, 21, 34, 53, 54, 59, 60, 68, 74, 75], "plane_norm": 68, "plate": [35, 76, 82, 83, 86, 87], "platform": 91, "platon": 73, "plausibl": [82, 86], "pleas": [4, 9, 63, 72, 77, 78, 79, 80, 81, 83, 84, 85, 86, 87, 88, 90], "plenti": 81, "plop": 73, "plot": [1, 12, 15, 31, 57, 59, 62, 63, 67, 68, 70, 73, 74, 76, 81, 82, 83, 84, 85, 86, 87, 96], "plot_centroid_analysi": [53, 59, 60], "plot_displac": 11, "plot_histogram": 11, "plot_model_compon": 15, "plot_scaling_model": 15, "plot_scan_varying_model": [71, 74], "plot_search_scop": 64, "plotli": 15, "plu": [3, 14, 15, 30, 82, 86, 87], "plug": [73, 75], "plugin": 4, "pmatrix": 2, "pmc": [73, 74, 75, 95], "pmc3382516": 95, "pmc3448510": 95, "pmc3689530": 95, "pmc3732582": 95, "pmc4008696": 95, "pmc4052861": 95, "pmc4052878": 95, "pmc4070675": 95, "pmc4119952": 95, "pmc4151126": 95, "pmc4156696": 95, "pmc4188007": 95, "pmc4248568": 95, "pmc4257623": 95, "pmc4260607": 95, "pmc4273327": 95, "pmc4321488": 95, "pmc4321489": 95, "pmc4344359": 95, "pmc4397907": 95, "pmc4403592": 95, "pmc4461207": 95, "pmc4607316": 95, "pmc4791177": 95, "pmc4822564": 95, "pmc5139990": 95, "pmc5619854": 95, "pmc5930348": 95, "pmc5947772": 95, "pmc6096487": [75, 95], "pmc6130462": 95, "pmc6450062": 95, "pmc7137103": 95, "pmc7737759": 73, "pmc8110528": 74, "pmc8313502": 73, "pmc8740827": 95, "pmc9159281": 95, "pmid": [73, 74, 75, 95], "png": [6, 11, 45, 57, 67, 68, 70, 76, 81, 83], "point": [2, 3, 7, 11, 14, 18, 38, 40, 44, 53, 54, 65, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93], "pointer": 26, "pointgroup": 53, "pointless": [18, 40, 44, 69, 75, 77, 84, 86], "pointless_combin": 75, "pointless_reindex_": 75, "poisson": [42, 78, 82, 86, 87], "pokeri": 6, "polar": [21, 38, 52, 82, 84, 86], "polarization_fract": [3, 21, 38, 52], "polarization_fraction_toler": 24, "polarization_norm": [3, 21, 38, 52], "polarization_normal_toler": 24, "polarization_plane_norm": 21, "polici": 14, "polish": 87, "polychromat": [11, 52, 53], "polychromaticbeam": 21, "polygon": [47, 50, 51], "polyhedrin": 95, "polynomi": [43, 72], "poon": [0, 53, 59, 60], "poor": [75, 77, 80, 81, 82, 83, 86, 87], "poorer": [1, 84], "poorli": [1, 47, 53, 59, 60, 73, 74, 76, 84, 87], "pop": 87, "popul": [15, 26, 33, 84, 96], "port": 49, "posit": [0, 1, 2, 3, 11, 14, 15, 33, 47, 53, 54, 59, 60, 63, 64, 66, 69, 72, 73, 74, 75, 76, 78, 79, 81, 82, 84, 85, 86, 87, 88], "posix": 75, "possibl": [0, 1, 2, 4, 11, 18, 33, 34, 40, 53, 56, 59, 60, 69, 73, 74, 75, 76, 77, 78, 79, 82, 83, 84, 85, 86, 87, 88, 92], "possibli": [14, 18, 37, 76, 77], "post": [12, 82, 86, 87, 90, 95], "potenti": [14, 53, 59, 60, 61, 72, 73, 76, 82, 86], "pothineni": 95, "potter": 73, "powder": [45, 46, 47, 50, 51, 74, 75, 81, 82, 85, 86], "powder_arc": 51, "powel": [0, 98], "poweleit": 73, "power": [11, 53, 76, 82, 86], "pp": 0, "pr": 74, "practic": [2, 14, 73, 74, 77, 82, 84, 86, 87, 89], "pre": [1, 12, 82, 86, 87], "preced": 14, "precis": [44, 82, 86], "pred_param": 14, "predict": [3, 11, 14, 16, 17, 40, 41, 44, 51, 53, 54, 59, 60, 71, 74, 75, 81, 82, 83, 84, 85, 86, 87], "predict_for_free_reflect": 14, "predict_for_index": 14, "predict_for_reflection_t": 14, "predict_reflect": 51, "prediction_parameteris": 14, "predictionparamet": 14, "predictionparameteris": 14, "predictor": [14, 17], "prefer": [9, 18, 40, 47, 60, 69, 72, 74, 76, 81, 82, 83, 84, 86, 87], "prefilt": 15, "prefix": [7, 12, 44, 45, 47, 53, 59, 60, 83, 91], "preliminari": 72, "prepar": [7, 14, 63, 73, 76, 79, 83, 88], "prepare_for_step": 14, "preprocess": [47, 51, 82, 84, 86], "prerequisit": 9, "preselect": [82, 86], "presenc": [18, 40, 77, 84, 88, 95], "present": [0, 14, 15, 18, 33, 40, 44, 46, 53, 59, 60, 61, 66, 71, 72, 76, 77, 78, 81, 82, 84, 85, 86, 87, 88, 90, 99], "preserve_ord": 83, "press": [2, 78, 87], "pressur": 35, "presum": [23, 74], "pretend": 4, "pretti": [18, 78, 87], "preview": [82, 86, 87], "previou": [63, 75, 76, 81, 82, 84, 86, 87], "previous": [15, 82, 84, 86], "prf": [3, 40, 54, 74, 81, 82, 84, 85, 86], "primari": [25, 33, 34, 74], "primarili": [11, 44, 53, 82, 86, 87], "prime": 2, "primit": [11, 53, 60, 73, 77, 78, 82, 86, 87, 88], "princip": [14, 40, 76, 84], "principl": [11, 21, 34], "print": [6, 7, 12, 14, 18, 33, 46, 47, 57, 60, 65, 74, 78, 82, 83, 86, 87], "print_exp_rmsd_t": 14, "print_funct": 4, "print_help": 6, "print_out_of_sample_rmsd_t": 14, "print_panel_rmsd_t": 14, "print_stats_on_match": 14, "print_step_t": 14, "print_tim": 33, "printabl": 71, "printf": 76, "prior": [2, 11, 54, 74, 82, 86, 87, 88, 92], "prioriti": 52, "privat": [9, 14], "probabl": [1, 11, 18, 40, 41, 51, 53, 54, 58, 59, 60, 73, 76, 82, 84, 85, 86], "probe": [21, 52, 82, 86], "problem": [0, 14, 74, 77, 78, 79, 82, 83, 84, 86, 87, 93], "problemat": 14, "proc": [74, 75, 95], "proce": [53, 59, 60, 76, 78, 82, 84, 85, 86, 87, 88, 93], "procedur": [11, 40, 72, 74, 82, 83, 84, 86, 87], "proceed": [0, 11, 74, 76, 77], "process": [0, 1, 3, 7, 12, 14, 16, 31, 38, 40, 41, 44, 47, 48, 51, 52, 53, 54, 58, 59, 60, 63, 71, 72, 75, 77, 78, 79, 80, 81, 82, 84, 85, 88, 89, 95, 97], "process_includ": 6, "process_sequ": 83, "process_teha": 83, "processor": [12, 14, 16, 48, 54, 72, 82, 83, 86, 87], "processor2d": [12, 19], "processor3d": [12, 19], "processorclass": 12, "processorflat3d": [12, 19], "processorsingle2d": [12, 19], "processorstil": [12, 19], "processs": 84, "procur": 92, "produc": [7, 38, 44, 53, 54, 59, 60, 66, 74, 75, 77, 78, 81, 82, 83, 84, 86, 87, 96], "product": [2, 11, 92], "product_nam": 33, "product_specific_finalize_instal": 33, "profil": [1, 3, 12, 24, 27, 31, 32, 35, 40, 41, 44, 47, 51, 54, 58, 63, 72, 74, 77, 78, 81, 82, 83, 84, 85, 86, 87, 94], "profile_fitt": 12, "profile_model": [3, 4, 19, 32], "profile_model_report": 12, "profile_validation_report": 12, "profilemodelfactori": [27, 28], "profilemodellerexecutor": [12, 19], "profilevalidatorexecutor": [12, 19], "profit": 92, "program": [1, 3, 7, 8, 34, 35, 36, 37, 40, 41, 42, 44, 46, 47, 50, 51, 52, 53, 54, 55, 58, 60, 61, 62, 63, 69, 72, 73, 74, 77, 78, 79, 82, 83, 84, 85, 86, 87, 88, 96, 99], "progress": [18, 33, 85, 94], "progressbar": [32, 33], "progressbartim": [32, 33], "prohibit": 1, "project": [0, 2, 11, 44, 45, 51, 63, 68, 76, 79, 83, 84, 85, 90, 95, 97, 98], "project_nam": [33, 44, 63], "project_root": 48, "project_src": 48, "promot": 92, "prompt": 74, "proper": [17, 33, 73], "properli": [7, 74, 75, 77, 78, 83, 84], "properti": [1, 2, 11, 14, 15, 18, 25, 26, 29, 33, 35, 47, 95], "proport": 74, "propos": [82, 86, 87], "prospect": 97, "proteas": 80, "protein": [63, 73, 74, 75, 82, 83, 95], "proteinas": 84, "protocol": [75, 83], "prototyp": 0, "provid": [0, 1, 4, 7, 11, 14, 15, 18, 23, 24, 33, 36, 38, 40, 43, 47, 50, 51, 52, 53, 54, 61, 63, 66, 69, 70, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 91, 92, 96, 97], "proxim": 53, "prudent": [74, 87], "pseudo": [77, 84], "pseudocentr": 78, "pseudoinvers": 14, "psi": [2, 14], "psi_i": 2, "psi_x": 2, "psi_z": 2, "pt": 73, "public": [0, 14, 74, 75], "publish": [0, 74, 82], "pull": [4, 87], "pure": [2, 14], "purpos": [59, 74, 77, 81, 82, 83, 86, 87, 92], "push": 74, "put": [7, 53, 74, 78], "pwd": 75, "px": [3, 47, 50, 51, 52, 73, 74, 78, 81, 82, 83, 85, 86], "px_mm": 23, "px_mm_strategi": 3, "px_sz": [53, 59, 60], "py": [4, 9, 73, 75, 83], "python": [0, 3, 4, 7, 9, 22, 23, 24, 25, 26, 79, 83, 95], "python2": 79, "q": [84, 85, 95], "q1": [81, 82, 83, 86], "q3": [81, 82, 83, 86], "qe": 3, "quad": [53, 75], "quadrat": 63, "qualiti": [1, 45, 48, 49, 72, 73, 74, 78, 81, 82, 84, 85, 86, 87, 95, 97], "quantil": [53, 59, 60], "quantiti": 6, "quantum": 3, "quarter": [81, 84, 87], "quasi": [18, 40, 69, 72, 84, 94], "quasi_random": [1, 63, 72], "queri": 14, "question": [76, 78, 80, 84], "quick": [1, 49, 63, 74, 81, 83], "quick_pars": 33, "quicker": 81, "quit": [11, 21, 44, 53, 73, 74, 75, 78, 84], "r": [0, 1, 2, 6, 11, 15, 18, 35, 40, 43, 47, 50, 51, 63, 69, 72, 73, 76, 77, 84, 85, 93, 95], "r01": [0, 90], "r_": [2, 18, 76], "r_0": 2, "r_anom": [73, 82, 84, 86], "r_free_arrai": 33, "r_free_flag": 72, "r_mea": [73, 82, 84, 85, 86], "r_mrg": [73, 82, 84, 85, 86], "r_pim": [73, 82, 84, 85, 86], "ra": 95, "rad": [3, 14, 53, 59, 60, 84], "radial": [11, 47], "radial_profil": 47, "radialaverag": [10, 19], "radian": [11, 53, 54], "radiat": [1, 72, 73, 74, 78, 81, 82, 84, 86, 87, 95], "radiu": [53, 64], "rahaman": 74, "rai": [2, 11, 22, 33, 35, 52, 73, 74, 78, 82, 86, 90, 94, 95, 97], "rainbow": [45, 51], "rais": [15, 52, 53, 59, 60], "ram": 81, "ran": [76, 83], "random": [14, 38, 53, 54, 59, 60, 63, 64, 72, 81, 84], "random_se": [53, 54, 59, 60], "randomli": [63, 72, 82, 84, 86, 97], "rang": [1, 15, 16, 26, 47, 50, 51, 52, 53, 54, 59, 60, 63, 64, 66, 69, 72, 74, 79, 82, 83, 84, 85, 86, 87], "rank": 40, "ranom": 84, "rapid": [0, 96, 97], "rapidli": 76, "raster": [48, 76], "rate": [81, 83, 87, 97], "rather": [1, 2, 7, 63, 74, 75, 76, 78, 81, 82, 83, 86, 87, 88, 97], "ratio": [14, 40, 76, 84], "raw": [3, 9, 44, 45, 47, 48, 55, 65, 73, 75, 82, 86, 87], "rawdata": 48, "rawdescriptionhelpformatt": 33, "rb": 95, "re": [16, 34, 48, 60, 61, 72, 75, 76, 83, 84, 85], "reach": [14, 53, 59, 60, 97], "read": [1, 2, 3, 4, 5, 23, 24, 25, 26, 29, 33, 40, 55, 73, 74, 78, 82, 83, 84, 85, 86, 87], "read_experi": [6, 33], "read_experiments_from_imag": 33, "read_fil": 33, "read_reflect": [6, 33], "readabl": 3, "reader": [26, 32, 33, 71, 74, 78], "readi": [7, 44, 75, 83, 87], "real": [2, 4, 11, 76, 77, 78, 81, 82, 83, 86, 87, 95, 96], "real_space_a": [3, 22, 30], "real_space_b": [3, 22, 30], "real_space_c": [3, 22, 30], "real_space_grid_search": [4, 11, 53, 87, 96], "realist": 76, "realiti": 83, "realli": [73, 76, 81, 83], "realspacegridsearch": 11, "reason": [1, 2, 53, 59, 60, 73, 74, 75, 76, 77, 78, 82, 83, 84, 85, 86, 88], "reason_for_termin": 14, "rebuild": 77, "recent": [33, 79, 84, 90, 97], "receptor": 74, "reciproc": [1, 2, 3, 4, 11, 14, 18, 22, 31, 34, 40, 41, 44, 51, 53, 54, 58, 72, 74, 77, 78, 82, 84, 86, 87, 88], "reciprocal_lattice_point": 11, "reciprocal_lattice_vector": [4, 11], "reciprocal_lattice_view": [74, 76, 77, 78, 81, 82, 86, 87, 88], "reciprocal_spac": [41, 51, 54, 58], "reciprocal_space_grid": 53, "recognis": [24, 74, 78], "recombin": 93, "recommend": [1, 3, 7, 53, 59, 60, 63, 73, 74, 75, 82, 84, 85, 86], "reconcil": 2, "reconstruct": 11, "record": [2, 4, 14, 15, 44, 53, 59, 60, 73, 74, 76, 77, 78, 79, 81, 82, 83, 85, 86, 88], "record_intensity_combination_imid": 15, "recov": 35, "recreat": 75, "rectangl": [47, 50, 51, 75], "rectangular": 14, "recycle_unindexed_reflections_cutoff": 53, "red": [45, 73, 74, 82, 86, 87], "redefin": 2, "redistribut": 92, "reduc": [1, 2, 14, 15, 35, 40, 45, 47, 51, 53, 59, 60, 66, 72, 73, 76, 82, 83, 86, 87, 88], "reduct": [14, 53, 77, 80, 82, 86, 87, 97], "redund": [84, 85], "ree": 0, "ref": [10, 43, 72], "refelct": 63, "refer": [2, 8, 14, 18, 21, 23, 25, 29, 37, 38, 40, 41, 43, 51, 52, 54, 57, 58, 61, 62, 63, 66, 71, 72, 75, 81, 82, 86, 87, 89, 96], "reference_from_experi": [38, 81, 83, 93], "reference_geometri": [52, 75], "reference_miller_set": 18, "reference_model": [40, 61, 63], "reference_profil": 54, "reference_spot": 46, "refin": [1, 3, 4, 11, 15, 18, 19, 32, 38, 41, 44, 46, 51, 53, 54, 57, 58, 60, 62, 63, 70, 71, 72, 76, 77, 78, 79, 80, 84, 89, 95, 96, 98], "refine_all_candid": 53, "refine_bravais_set": [71, 73, 74, 75, 77, 78, 82, 85, 86, 87, 88], "refine_candidates_with_known_symmetri": 53, "refine_shel": 53, "refined_cel": [70, 88], "refined_experi": 75, "refined_lev0": 81, "refined_lev1": 81, "refinement_ord": 63, "refinement_param": 11, "refinement_protocol": 53, "refinerfactori": [14, 19], "refineri": [14, 19, 53, 59, 60, 63], "refl": [1, 3, 6, 35, 37, 38, 40, 41, 43, 44, 46, 47, 51, 53, 54, 56, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 69, 70, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 88, 93, 96], "reflect": [2, 4, 6, 10, 11, 12, 14, 15, 16, 17, 18, 31, 33, 35, 37, 38, 40, 41, 43, 44, 46, 47, 51, 53, 54, 56, 58, 59, 60, 61, 63, 64, 65, 66, 68, 69, 70, 72, 73, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 89, 96, 98], "reflection_file_object_list": 33, "reflection_manag": 14, "reflection_predictor": 17, "reflection_select": [1, 63, 72], "reflection_t": [3, 4, 11, 12, 15, 16, 33, 83], "reflection_table_selector": 54, "reflectionmanag": [12, 14, 19], "reflectionmanagerfactori": [14, 19], "reflectionpredictor": [17, 19], "reflections_": [88, 93], "reflections_0": [38, 40, 84, 88], "reflections_1": [38, 40, 84, 88], "reflections_2": [40, 84, 88], "reflections_3": [40, 84, 88], "reflections_after_outlier_reject": 14, "reflections_and_experiments_from_fil": [32, 33], "reflections_filenam": [38, 66], "reflections_per_bin": [43, 72], "reflections_per_degre": [41, 51, 53, 54, 58, 59, 60], "refman": 14, "refresh": 4, "regard": [74, 87], "regardless": 1, "region": [2, 11, 16, 46, 47, 56, 74, 75, 77, 81, 84, 87], "region_of_interest": [16, 47], "regist": 4, "registri": 4, "regular": [1, 47, 54, 63, 66, 69, 72, 76, 78, 81, 85, 96], "regular_grid": [41, 51, 54, 58], "rehanek": 95, "reindex": [18, 24, 40, 53, 60, 71, 72, 73, 74, 75, 76, 77, 78, 82, 84, 85, 86, 87, 88], "reindex_to_refer": 18, "reintegr": 54, "reinvent": 0, "reject": [1, 14, 15, 43, 46, 47, 50, 51, 53, 54, 59, 60, 63, 72, 73, 81, 82, 83, 84, 85, 86, 87], "reject_fract": 46, "reject_outli": 15, "rejectiob": 15, "rejector": [53, 54, 59, 60], "rel": [1, 11, 15, 18, 47, 53, 57, 62, 63, 72, 76, 81, 82, 83, 84, 86, 87, 88], "relat": [1, 2, 14, 37, 39, 53, 59, 60, 73, 76, 77, 78, 82, 83, 84, 86, 87], "relationship": [2, 3, 52], "relative_b_correct": 63, "relative_length_toler": [11, 18, 40, 53, 69, 72], "relative_to_complete_set": 72, "relative_to_static_orient": [57, 62], "releas": 7, "relev": [14, 43, 44, 82, 84, 86, 87], "reli": 93, "reliabl": [63, 73, 82, 84, 86, 88], "relocat": 62, "relp": [53, 59, 60], "remain": [0, 2, 11, 14, 38, 53, 54, 59, 60, 74, 75, 78, 82, 85, 86, 87], "remap": 16, "rememb": [73, 78, 81, 83], "remind": [1, 81], "remot": [62, 79], "remov": [1, 4, 35, 40, 50, 53, 54, 59, 60, 63, 66, 70, 72, 73, 74, 76, 82, 83, 84, 85, 86, 87, 93], "remove_on_experiment_identifi": 24, "remove_profile_fitting_failur": 72, "remove_sources_default": 33, "renumb": 33, "reopen": 24, "repeat": [38, 47, 63, 73, 74, 75, 81, 83, 84, 87, 96], "repeatedli": 76, "repetit": 63, "replac": [9, 24, 38, 52, 73, 74, 75, 77, 83], "replot": [59, 70], "report": [1, 12, 14, 40, 42, 48, 54, 63, 67, 69, 70, 71, 74, 76, 78, 84, 85, 87, 90, 96], "report_progress": 14, "repositori": [4, 9, 53, 59, 60, 75], "repredict_onli": 53, "repres": [2, 12, 40, 44, 52, 81, 82, 86, 87], "represent": [2, 15, 18, 52, 84], "reprint": [73, 74, 75, 95], "reprocess": [73, 86, 87], "reproduc": [74, 75, 77, 82, 83, 86, 87, 92], "request": [4, 14, 26, 43, 48, 53, 59, 60, 78, 81, 90], "requir": [4, 7, 11, 14, 15, 18, 44, 52, 53, 54, 59, 60, 62, 73, 74, 75, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 90, 93, 95, 97], "rerun": [83, 84, 85, 88], "rescal": [72, 82, 86], "rescale_after_resolution_cutoff": 72, "rescu": 83, "research": [90, 92], "reserv": 92, "reset": [14, 63, 73], "reset_accepted_reflect": 14, "reset_error_model": 63, "reset_scan_point": 25, "residu": [14, 53, 59, 60, 76, 81, 82, 86, 87], "resiz": 87, "resolut": [1, 11, 17, 18, 37, 38, 40, 41, 43, 44, 45, 46, 47, 48, 49, 50, 51, 53, 54, 60, 63, 67, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95], "resolution_analysi": 67, "resolution_depend": 63, "resolution_filter_from_arrai": [18, 19], "resolution_filter_from_reflections_experi": [18, 19], "resolution_r": 45, "resolution_rang": [47, 50, 51], "resolv": [72, 74, 76, 82, 86, 87], "resolve_indexing_ambigu": 72, "resourc": 1, "respect": [18, 35, 39, 63, 76, 79, 84], "respons": [47, 49, 74], "rest": [1, 11, 40, 74, 84], "restart": 14, "restrain": [1, 53, 59, 60, 63, 75], "restraint": [14, 53, 59, 60, 63, 74, 75, 83, 88], "restraints_param": 14, "restraints_parameteris": 14, "restrict": [44, 53, 59, 60, 83, 84], "result": [1, 2, 11, 14, 15, 18, 35, 37, 38, 39, 40, 42, 43, 44, 51, 53, 57, 59, 60, 63, 64, 66, 67, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 88, 93, 96], "retain": [38, 44, 54, 76, 92], "retrospect": 97, "return": [1, 4, 6, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 29, 30, 31, 33, 49, 53, 59, 60, 74, 83, 87], "return_unhandl": 33, "reus": [0, 94], "reusabl": 2, "reveal": [74, 77], "revers": [4, 11, 25, 44, 78], "revis": [87, 95], "revisit": 76, "reweight": 63, "rewrit": 81, "rey": 95, "rf": 95, "rg": 95, "rho": 35, "rice": 73, "richard": 0, "rigaku": 23, "right": [2, 4, 35, 73, 74, 78, 81, 83, 92], "rigid": [53, 59, 60, 81], "rigor": 74, "rij": [18, 40, 72], "ring": [44, 45, 46, 47, 49, 50, 51, 53, 54, 74, 75, 81, 82, 84, 85, 86, 95], "riordan": [0, 95], "risk": 76, "rj": 95, "rl": 95, "rlp": [3, 44, 53], "rlp_mosaic": [41, 51, 54, 58], "rm": 84, "rmat": 33, "rmea": [63, 74, 76, 79, 82, 84, 86, 87, 88], "rmerg": [43, 72, 74, 76, 79, 82, 84, 86, 87, 88], "rmsd": [11, 14, 53, 59, 60, 63, 73, 74, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 96], "rmsd_cutoff": [11, 53, 59, 60], "rmsd_deltapsi": 14, "rmsd_i": [82, 84, 86], "rmsd_min_px": 53, "rmsd_name": 14, "rmsd_phi": [14, 81, 82, 83, 85, 86, 87], "rmsd_target_mm": 53, "rmsd_toler": 63, "rmsd_unit": 14, "rmsd_weight": [11, 53], "rmsd_x": [14, 73, 74, 78, 81, 82, 83, 85, 86, 87], "rmsd_xy": [82, 86], "rmsd_y": [14, 73, 74, 78, 81, 82, 83, 85, 86, 87], "rmsd_z": [73, 74, 78, 81, 82, 83, 85, 86], "rmsds_for_experi": 14, "rmsds_for_panel": 14, "rmsds_for_reflection_t": 14, "robert": 0, "robust": [53, 54, 59, 60, 76, 95], "rock": 74, "rodriguez": 95, "roi": 47, "room": [83, 95], "root": [4, 53, 59, 60, 74], "rossmann": 11, "rotat": [1, 2, 4, 6, 11, 14, 22, 25, 33, 34, 35, 38, 39, 47, 52, 53, 54, 57, 59, 60, 62, 63, 68, 72, 73, 74, 75, 76, 78, 81, 82, 84, 85, 86, 87, 93, 96, 97], "rotate_around_origin": [23, 25], "rotate_cryst": [32, 33], "rotation_angle_deg": 54, "rotation_axi": [3, 25, 38], "rotation_axis_toler": [24, 25], "rotation_matrix_differ": 11, "rotogram": 53, "rotogram_grid_point": 53, "rough": 78, "rougher": 87, "roughli": [11, 43], "round": [1, 53, 63, 72, 73, 74, 78, 79, 82, 84, 86], "rousseeuw": [53, 59, 60], "routin": [1, 63, 88], "row": 14, "rpim": [1, 74, 76, 79, 82, 84, 86, 87, 88], "rsmd": [14, 83], "rt_mx": 18, "rub": 2, "rubi": 83, "rule": [53, 59, 60], "run": [1, 4, 6, 7, 9, 14, 15, 16, 18, 38, 40, 43, 44, 48, 53, 55, 59, 60, 63, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 96], "run_lbfg": 14, "runtim": [4, 75], "runtimeerror": 11, "rupp": 2, "rw": 95, "s0": [6, 21, 23, 43], "s0021889810010782": [53, 59, 60], "s1": [3, 23, 41, 51, 54, 58], "s1600576714007626": 47, "s2053273319015559": 11, "s2059798317010348": 75, "sacrifici": 83, "sad": [44, 88], "sadab": 44, "saeed": 0, "sai": [7, 53, 59, 60, 78, 83, 87], "same": [1, 2, 11, 14, 23, 24, 36, 44, 54, 59, 61, 66, 70, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 87, 96], "sampl": [2, 11, 14, 18, 23, 35, 52, 53, 54, 59, 60, 73, 74, 76, 81, 82, 86, 87, 88], "sample_to_sourc": 21, "sample_to_source_dist": [21, 52], "sanchez": 95, "sandi": 95, "sandwich": 35, "sangwan": 95, "sanishvili": 95, "saniti": 53, "sar": 80, "satellit": 84, "satisfi": [81, 87], "satur": 45, "saturn": 23, "sauter": [0, 2, 11, 48, 53, 59, 60, 64, 95, 97], "sauter_poon": [53, 59, 60, 83], "save": [3, 38, 40, 41, 47, 50, 52, 54, 58, 63, 74, 75, 81, 82, 83, 84, 85, 86, 87, 88, 96], "save_coordin": 68, "saw": 73, "sawaya": 95, "sb": 95, "sbgrid": 74, "sc": 79, "sca": 72, "scalar": 11, "scale": [2, 3, 18, 19, 22, 24, 32, 35, 40, 43, 44, 45, 48, 56, 71, 72, 76, 78, 79, 80, 83, 89, 94, 95], "scale_and_filter_result": 63, "scale_compon": 4, "scale_correct": 1, "scale_interv": [1, 63, 87], "scale_rang": 44, "scalecomponentbas": 4, "scaled_unmerg": [43, 44, 76], "scaler": [15, 84], "scaling_model": 24, "scaling_model_ext": 4, "scaling_opt": 63, "scaling_refineri": 63, "scalingmodelbas": [4, 15], "scan": [2, 3, 4, 6, 14, 16, 17, 24, 25, 26, 27, 32, 38, 41, 44, 47, 48, 49, 51, 52, 53, 54, 57, 58, 59, 60, 63, 65, 66, 68, 69, 72, 73, 74, 76, 81, 82, 83, 85, 86, 87, 88, 93, 97], "scan_axi": [25, 52], "scan_margin": [14, 53, 59, 60], "scan_rang": [16, 47, 54], "scan_step": [41, 51, 54, 58], "scan_toler": [24, 33], "scan_vari": [41, 51, 53, 54, 58, 59, 60, 73, 74, 75, 81, 82, 83, 93], "scanaxi": 25, "scanfactori": [27, 29], "scanvaryingrefin": [14, 19], "scapin": 73, "scatter": [1, 2, 47, 53, 59, 60, 63, 74, 82, 86, 87, 95], "scene": 97, "sceptic": 78, "schafer": 95, "schemat": 35, "scheme": [14, 63, 82, 86, 87], "schlicht": 95, "school": 76, "schuermann": 0, "sci": [73, 95], "scienc": [0, 33, 79, 82, 90, 95], "scientif": 94, "scientist": 83, "scipi": [18, 40, 72], "scisoft": [33, 79, 82], "scitbx": [4, 6, 10, 11, 12, 14, 18, 22, 23, 24, 25, 26, 40, 72], "scope": [11, 12, 15, 33, 37, 53], "scope_extract": [18, 21], "score": [1, 11, 18, 40, 63, 69, 73, 76, 77, 79, 82, 84, 85, 86, 87, 88], "score_by_fraction_index": 11, "score_by_rmsd_xi": 11, "score_by_volum": 11, "score_vector": 11, "scorecorrelationcoeffici": [18, 19], "scoresubgroup": [18, 19], "scoresymmetryel": [18, 19], "scratch": [9, 79, 83, 86], "screen": [82, 86], "screw": [84, 85], "script": [4, 6, 7, 9, 33, 38, 76, 83], "scroll": [73, 87], "sd": [82, 86, 88], "se": 95, "seamless": 0, "search": [11, 29, 37, 38, 53, 59, 60, 64, 74, 77, 78, 83, 85, 96], "search_beam_posit": [71, 78], "search_depth": 53, "search_direct": 11, "search_vector": 11, "second": [1, 18, 34, 73, 77, 78, 82, 83, 86, 87], "secondari": 72, "sect": 2, "section": [1, 3, 74, 76, 77, 82, 86, 87], "see": [1, 2, 7, 9, 11, 18, 47, 48, 53, 54, 59, 60, 63, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 91, 96], "seed": [18, 40, 53, 54, 59, 60, 64, 69, 72], "seed_dataset": 18, "seem": [1, 44, 74, 81, 83], "seen": [75, 81, 82, 86, 87], "seibert": 95, "sel": 14, "select": [1, 6, 11, 14, 15, 38, 40, 41, 43, 46, 51, 53, 54, 58, 59, 60, 63, 72, 74, 76, 78, 82, 84, 86, 87, 88], "select_good_intens": 46, "select_on_experiment_identifi": 24, "selection_used_for_refin": 14, "self": [4, 6, 12], "sellberg": 95, "seltzer": 35, "semi": 85, "semin": 0, "semisynthetic_multilattice_data": 85, "semisynthetic_multilattice_data_2": 85, "sens": 45, "sensibl": [1, 76, 82, 86, 87, 88], "sensit": [0, 11, 40, 84], "sensor": [2, 23], "sensor_pad": [82, 86], "sensor_unknown": 3, "sep": 95, "separ": [1, 14, 15, 38, 40, 43, 47, 53, 54, 59, 60, 63, 70, 72, 73, 74, 75, 81, 82, 83, 85, 86, 93], "separate_block": [53, 59, 60], "separate_experi": [53, 59, 60], "separate_fil": 54, "separate_imag": [53, 59, 60], "separate_independent_set": 59, "separate_panel": [53, 59, 60], "septemb": 99, "sequenc": [2, 3, 15, 16, 24, 26, 30, 36, 47, 52, 53, 54, 59, 60, 63, 66, 78, 79, 81, 82, 83, 85, 86, 88, 96], "sequence_": 83, "sequence_00": 83, "sequence_01": 83, "sequence_02": 83, "sequence_03": 83, "sequence_04": 83, "sequence_08": 83, "sequence_09": 83, "sequence_11": 83, "sequence_12": 83, "sequence_13": 83, "sequence_14": 83, "sequence_16": 83, "sequence_17": 83, "sequence_19": 83, "sequence_20": 83, "sequence_21": 83, "sequence_22": 83, "sequence_23": 83, "sequence_24": 83, "sequence_25": 83, "sequence_26": 83, "sequence_27": 83, "sequence_28": 83, "sequence_29": 83, "sequence_31": 83, "sequence_32": 83, "sequence_33": 83, "sequence_35": 83, "sequence_38": 83, "sequence_39": 83, "sequence_40": 83, "sequence_41": 83, "sequence_42": 83, "sequence_43": 83, "sequence_44": 83, "sequence_45": 83, "sequence_46": 83, "sequence_47": 83, "sequence_48": 83, "sequence_50": 83, "sequence_53": 83, "sequence_54": 83, "sequence_55": 83, "sequence_57": 83, "sequence_58": 83, "sequence_59": 83, "sequence_60": 83, "sequence_61": 83, "sequence_62": 83, "sequence_63": 83, "sequence_64": 83, "sequence_65": 83, "sequence_66": 83, "sequence_67": 83, "sequence_68": 83, "sequence_69": 83, "sequence_70": 83, "sequence_71": 83, "sequenti": [39, 74], "seri": [0, 11, 53, 83, 97], "serial": [4, 15, 24, 27, 32, 53, 59, 60, 74, 83, 90, 95, 96, 97], "serialis": 24, "serlial": 83, "serv": 79, "server": [9, 49, 71], "servic": [73, 92], "session": [9, 97], "set": [1, 2, 3, 6, 7, 11, 12, 14, 15, 16, 18, 26, 29, 30, 33, 34, 37, 38, 40, 42, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 56, 58, 59, 60, 61, 63, 65, 68, 69, 72, 73, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 90, 91, 93, 95, 96, 97], "set_angl": 25, "set_ax": 25, "set_beam": 26, "set_cholesky_factor": 14, "set_detector": 26, "set_dimens": 18, "set_domain_size_ang": 22, "set_domain_size_ang_valu": 53, "set_error_model": 15, "set_fixed_rot": 25, "set_format_class": 26, "set_goniomet": 26, "set_half_mosaicity_deg": 22, "set_last_cel": 14, "set_mosa": 22, "set_mosaic_half_deg_valu": 53, "set_nproc": 14, "set_param": 26, "set_rotation_axi": 25, "set_rotation_axis_datum": 25, "set_scaling_model_as_sc": 15, "set_scaling_model_as_unsc": 15, "set_scan": 26, "set_scan_varying_error": [53, 59, 60], "set_setting_rot": 25, "set_setting_rotation_at_scan_point": 25, "set_shoebox_background_valu": [10, 19], "set_templ": 26, "set_valid_image_rang": 15, "set_vendor": 26, "setting_rot": [38, 52], "setting_rotation_matrix": 25, "setting_rotation_toler": [24, 25], "setup": [4, 14, 33, 91], "setup_index": 11, "setup_mu": 14, "setuptool": 4, "seven": 75, "sever": [1, 9, 49, 76, 77, 82, 83, 84, 86, 87], "sfac": 73, "sfx": 74, "sge": [47, 54], "sgtbx": [11, 18, 22, 24, 53], "sh": [7, 74, 91], "shadow": [11, 45, 47, 51, 52, 58, 81], "shall": [75, 78, 84, 85, 92], "shape": [50, 63, 82, 86, 87, 88], "share": [3, 10, 12, 14, 23, 24, 25, 26, 38, 59, 63, 72, 83, 93], "shared_ptr": [10, 24, 26], "shell": [1, 7, 43, 47, 72, 73, 74, 75, 76, 84, 88], "shelx": [44, 70, 73, 88], "shelxd": 73, "shelxt": [73, 88], "shi": 95, "shift": [14, 53, 59, 60, 62, 78, 81, 82, 86, 87], "shoebox": [3, 10, 16, 38, 41, 47, 51, 54, 58, 63, 74, 82, 86, 87, 88], "shoebox_memori": 12, "shoeboxes_to_reflection_t": [16, 19], "shoeman": 95, "short": [3, 44, 49, 77, 81, 83], "short_capt": [40, 43, 47, 52, 53, 54, 59, 60, 63, 69, 72], "shortcut": 83, "shorter": [11, 21, 74], "shortest": 11, "shorthand": [47, 54, 63, 69, 72], "shortli": [82, 86], "shot": [53, 95], "should": [1, 2, 4, 7, 14, 15, 18, 25, 38, 44, 50, 54, 63, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93], "show": [4, 22, 31, 33, 40, 45, 47, 51, 56, 71, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 87, 88, 96], "show_all_pix": 51, "show_all_reflection_data": 65, "show_beam_cent": 51, "show_centroid": 65, "show_correct": 65, "show_ctr_mass": 51, "show_diff_phil": [6, 33], "show_experi": 11, "show_flag": 65, "show_hkl": 51, "show_ice_r": 51, "show_identifi": 65, "show_index": 51, "show_integr": 51, "show_intens": 65, "show_mail_handle_error": 6, "show_mask": [45, 51], "show_max_pix": 51, "show_miller_indic": 51, "show_predict": 51, "show_profile_fit": 65, "show_raw": 65, "show_registri": 4, "show_resolution_r": 51, "show_rotation_axi": 51, "show_scan_vari": [22, 65], "show_shared_model": 65, "show_shoebox": 51, "show_threshold_pix": 51, "shown": [3, 4, 7, 52, 63, 73, 82, 83, 84, 86, 87], "shutterless": 97, "si": [73, 82, 84, 85, 86], "side": [14, 58, 74, 81], "sierecki": 74, "sierra": 95, "sig": [38, 40, 44, 82, 84, 85, 86], "sig_": 14, "sig_min": 14, "sigdano": 84, "sigf": [84, 85], "sigi": [38, 43, 54, 63, 72, 74, 79, 81, 82, 84, 85, 86], "sigimean": [84, 85, 86], "sigma": [1, 18, 40, 41, 51, 52, 53, 54, 58, 59, 60, 63, 69, 72, 74, 75, 76, 79, 82, 84, 85, 86, 87, 88], "sigma_": [45, 51], "sigma_b": [41, 45, 51, 54, 58], "sigma_background": 47, "sigma_cc": 18, "sigma_d": [82, 86, 87], "sigma_diverg": [3, 21, 52], "sigma_i": [81, 82, 86, 87], "sigma_m": [41, 51, 54, 58, 82, 86, 87], "sigma_m_algorithm": [41, 51, 54, 58], "sigma_phi_deg": 53, "sigma_strong": [47, 75], "sigma_tau": [43, 72], "sign": [14, 73, 82, 86, 87], "signal": [1, 74, 95], "signal_strength": 48, "signatur": [10, 12, 14, 22, 23, 24, 25, 26], "signific": [35, 38, 43, 47, 54, 63, 69, 72, 75, 81, 82, 83, 84, 86, 87], "significance_filt": [38, 54], "significance_level": 69, "significantli": [72, 73, 82, 84, 86, 87, 96], "silver": [51, 97], "similar": [1, 4, 15, 18, 40, 47, 52, 53, 74, 76, 77, 82, 83, 84, 85, 86, 87, 96], "similarli": 85, "simpl": [1, 4, 14, 15, 21, 23, 24, 31, 33, 47, 50, 51, 53, 54, 63, 72, 81, 83, 87], "simple1": [41, 51, 54, 58], "simple1angular1": [41, 51, 54, 58], "simple1angular3": [41, 51, 54, 58], "simple6": [41, 51, 54, 58], "simple6angular1": [41, 51, 54, 58], "simple_background_ext": 31, "simple_centroid_ext": 31, "simple_direct": 21, "simplebackgroundext": [31, 32], "simplecentroidext": [31, 32], "simplelbfg": [14, 19, 53, 59, 60, 63], "simplenormdevoutlierreject": 15, "simpli": [1, 2, 7, 14, 35, 40, 82, 83, 86, 87, 93], "simplic": 96, "simplifi": [2, 21], "simul": 95, "simultan": [74, 83, 87, 95], "sin": 2, "sinc": [2, 11, 35, 53, 54, 82, 86, 87, 88], "singl": [1, 2, 4, 11, 12, 14, 15, 16, 18, 24, 25, 29, 38, 40, 41, 45, 47, 48, 51, 52, 53, 54, 55, 58, 59, 60, 63, 66, 69, 70, 72, 74, 76, 77, 81, 82, 83, 85, 86, 87, 88, 93, 95], "single_axi": 25, "single_axis_goniometer_from_phil": 25, "single_axis_revers": [4, 25], "single_fil": 29, "single_file_indic": 26, "singleton": [40, 84], "singular": 14, "sit": 78, "site": [7, 75, 90], "situ": [76, 83, 84], "situat": [14, 74, 81, 82, 83, 86], "six": [75, 88], "size": [1, 4, 11, 18, 23, 26, 35, 38, 39, 41, 42, 43, 44, 45, 47, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 61, 62, 63, 64, 66, 68, 72, 73, 74, 81, 82, 84, 85, 86, 87, 96], "size_max": 52, "size_min": 52, "size_t": [12, 15, 16, 24, 26], "sj": 74, "sjsu": 18, "skinner": 95, "skip": [74, 96], "skip_deriv": 14, "slice": [53, 66, 74, 97], "slice_sequ": 71, "slide": 0, "slider": [73, 82, 86], "slightli": [29, 74, 81, 82, 83, 86, 87], "slippag": 2, "slope": [74, 76, 79, 82, 84, 86, 87, 88], "slow": [1, 23, 38, 44, 47, 50, 51, 52, 63, 72, 73, 74, 75], "slow_axi": [3, 23, 38, 52, 75, 82, 86], "slow_axis_toler": [23, 24], "slow_direct": 23, "slow_fast_beam_centr": 52, "sm": 95, "small": [1, 2, 11, 53, 59, 60, 76, 77, 78, 80, 81, 82, 84, 86, 87], "smaller": [18, 40, 53, 55, 59, 60, 66, 69, 72, 73, 74], "smallest": [14, 53, 59, 60], "smart_sigma": 54, "smeet": 0, "smith": 95, "smooth": [1, 82, 83, 86, 87], "smoother": [15, 53, 59, 60, 73, 75, 87], "smoothli": [1, 74, 82, 86, 87, 88, 93], "smtbx": 33, "smv": [73, 74], "snapshot": [11, 74, 95, 97], "snare": 95, "snippet": 81, "snow": 76, "so": [1, 2, 4, 11, 14, 16, 24, 26, 35, 40, 44, 53, 59, 60, 63, 70, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88], "soc": 95, "soft": 75, "softwar": [0, 2, 7, 11, 75, 82, 84, 85, 86, 90, 92, 94, 95, 97], "sokara": 95, "solid": 11, "solti": 95, "solut": [11, 14, 40, 53, 63, 73, 74, 75, 76, 77, 78, 79, 82, 83, 84, 85, 86, 87, 88], "solution_scor": 53, "solv": [77, 78, 82, 86, 87, 88], "solvent": 73, "some": [1, 2, 3, 4, 6, 7, 9, 14, 25, 33, 41, 53, 59, 60, 63, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 93, 94], "somehow": 76, "someth": [76, 78, 82, 83, 86], "sometim": [11, 52, 73, 82, 86], "somewhat": [7, 83], "somewher": 76, "song": 95, "sophist": [74, 82, 83, 87], "sorri": 93, "sort": [6, 33, 54, 78, 83, 84, 86], "sort_opt": 33, "sorted_": 75, "sorted_1": 75, "sorted_2": 75, "sorted_3": 75, "sorted_4": 75, "sorted_5": 75, "sorted_6": 75, "sorted_7": 75, "sourc": [0, 4, 9, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 30, 31, 33, 35, 44, 52, 78, 80, 81, 82, 83, 84, 85, 86, 87, 91, 92, 94, 95, 99], "source_nam": 44, "source_packag": 33, "source_short_nam": 44, "sourceforg": [79, 90], "space": [1, 2, 4, 7, 11, 14, 15, 18, 22, 31, 33, 37, 40, 41, 43, 44, 45, 46, 47, 50, 51, 53, 54, 58, 59, 60, 61, 63, 72, 73, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 96], "space_group": [11, 18, 22, 30, 33, 34, 39, 40, 43, 45, 46, 47, 50, 51, 53, 61, 69, 72, 73, 74, 77, 81, 82, 83, 85, 86, 88, 96], "space_group_hall_symbol": 3, "space_group_info": 11, "space_group_numb": 30, "space_group_symbol": 22, "spacegroup": [51, 75, 79], "spallat": 94, "span": 84, "spars": [14, 18, 40, 53, 59, 60, 81, 95, 96], "sparsegradientsmixin": [14, 19], "sparselevmar": [53, 59, 60], "spatial": 11, "speaker": 0, "special": [2, 4, 11, 51, 53, 59, 60, 63, 73, 74, 75, 76, 87, 92], "special_correct": 4, "specialcompon": 4, "specif": [0, 2, 4, 7, 53, 54, 59, 70, 74, 75, 76, 82, 83, 86, 87, 92], "specifi": [1, 2, 11, 14, 15, 33, 34, 36, 38, 43, 46, 47, 50, 51, 52, 53, 54, 59, 60, 61, 63, 64, 66, 68, 69, 70, 72, 74, 81, 83, 84, 91, 96], "spectral": 11, "spectroscopi": 95, "spectrum": 26, "speed": [0, 45, 53, 54, 59, 60, 73, 81, 82, 86, 87, 96, 97], "spell": 76, "spend": 77, "sphere": [14, 53, 59, 60, 74], "spheric": [1, 53, 59, 60, 63, 72, 88], "spherical_grid": [41, 51, 54, 58], "spherical_relp_model": [53, 59, 60], "spindl": [14, 53, 59, 60, 81, 82, 86, 87], "spinner": 33, "spiral": 78, "spirit": 0, "split": [4, 12, 14, 24, 38, 47, 51, 53, 54, 59, 60, 63, 66, 77, 78, 81, 82, 83, 85, 86, 88, 93, 96], "split_": 83, "split_0": 85, "split_00": 83, "split_1": 85, "split_57": 83, "split_experi": [54, 81, 83, 85, 88, 93], "split_jacobian_into_block": 14, "split_json": 67, "split_matches_into_block": 14, "spot": [4, 11, 16, 35, 41, 42, 44, 45, 47, 49, 50, 51, 53, 54, 58, 59, 60, 64, 67, 77, 79, 81, 83, 85, 93, 96], "spot_count": 49, "spot_count_no_ic": 49, "spot_counts_per_imag": 71, "spot_dens": 47, "spot_find": [19, 32], "spot_predict": [19, 32], "spotdensityfilt": [16, 19], "spotfind": [16, 19, 47, 48, 75, 79, 82, 86, 95, 96], "spotfinderfactori": [16, 19], "spread": [22, 63, 76, 78, 79], "spring": 76, "sqr": 6, "sqrt": [2, 18, 40, 72, 82, 84, 86], "squar": [14, 53, 59, 60, 74, 82, 86, 87], "src": [4, 33], "ssh": 9, "ssrl_p6": 48, "ssx": 89, "ssx_index": 89, "ssx_integr": 89, "stabil": 83, "stabilis": 75, "stabl": [7, 88], "stacei": 74, "stack": 12, "stack_imag": 51, "stack_mod": 51, "staff": 4, "stage": [2, 35, 73, 74, 75, 77, 82, 86, 87, 88], "stai": [14, 76], "stan": 95, "standard": [1, 2, 15, 21, 23, 25, 35, 40, 47, 54, 63, 70, 72, 74, 75, 76, 79, 81, 83, 84, 85, 88, 96], "standard_error": [18, 40, 72], "standardis": 2, "star": [18, 77], "start": [1, 2, 8, 15, 18, 23, 25, 33, 47, 48, 53, 54, 59, 60, 63, 68, 69, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 91, 98], "stat": [48, 63], "state": [2, 14, 53, 59, 60, 82, 86], "static": [11, 12, 14, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 31, 41, 44, 51, 53, 54, 57, 58, 59, 60, 62, 73, 74, 81, 82, 83, 87, 88], "static_onli": 23, "staticmethod": 4, "statist": [1, 14, 42, 43, 44, 47, 48, 53, 59, 60, 63, 65, 67, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 96], "statisticalweightingstrategi": [14, 19], "statprim": 18, "statu": [3, 79], "std": [10, 22, 23, 24, 25, 26, 40, 63, 72, 79, 84], "std_string": [23, 24, 25], "stdcutoff": [63, 72], "stddev": [76, 84], "stdin": 52, "steadi": 87, "steep": [43, 86], "stef": 0, "steller": [11, 53], "step": [9, 14, 18, 40, 44, 45, 53, 54, 59, 60, 63, 70, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 97], "step_backward": 14, "step_forward": 14, "step_siz": [11, 53], "step_threshold": 14, "stepanov": 95, "stepwis": 96, "stereograph": [68, 76], "stereographic_project": 71, "stevenson": 95, "stfc": [90, 94], "still": [1, 3, 9, 11, 12, 14, 16, 24, 52, 53, 54, 59, 60, 63, 73, 74, 75, 76, 78, 81, 82, 83, 85, 86, 87, 95, 96], "stills_index": 19, "stills_process": [16, 96], "stillsindex": 11, "stillsindexerbasisvectorsearch": 11, "stillsindexerknownorient": 11, "stillsindexerlatticesearch": 11, "stillsreflectionmanag": [14, 19], "stillsweightingstrategi": [14, 19], "stop": [11, 15, 41, 47, 49, 51, 54, 58, 63, 69, 72, 74, 75, 82, 84, 86], "storag": 14, "store": [3, 4, 14, 18, 48, 57, 74, 75], "str": [4, 6, 11, 15, 18, 21, 22, 24, 25, 26, 33, 34, 36, 37, 38, 40, 41, 42, 44, 45, 46, 47, 50, 51, 52, 53, 54, 57, 58, 59, 60, 61, 63, 64, 66, 68, 69, 70, 72], "straight": [78, 81, 82, 86, 87], "straightforward": [73, 76, 77, 88], "strain": 95, "strategi": [11, 14, 16, 47, 53, 59, 60, 82, 86, 95], "streamwrapp": 33, "strength": [1, 74, 76, 88, 95], "strict": 92, "strictli": [82, 84, 85, 86], "string": [7, 12, 14, 33, 43, 47, 49, 53, 54, 59, 60, 63, 68, 69, 70, 72], "strong": [1, 3, 16, 44, 47, 49, 51, 53, 54, 62, 64, 67, 70, 73, 74, 75, 76, 77, 78, 81, 82, 83, 85, 86, 87, 88, 96], "strongli": [1, 63, 84], "struct": [3, 75, 95], "structur": [0, 7, 14, 24, 53, 59, 60, 63, 74, 75, 76, 77, 78, 82, 84, 85, 86, 87, 88, 90, 95, 97], "struggl": 73, "stuart": [11, 95, 97], "studi": [0, 95], "stuff": [12, 33], "style": [4, 53, 72], "stype": 23, "sub": [40, 46, 53, 59, 60, 73, 76, 77, 82, 84, 85, 86, 87, 90], "subclass": [4, 14, 15], "subdirectori": [74, 76, 84, 86, 87], "subgroup": 18, "subgroups_t": 18, "subject": 18, "submit": [4, 83, 95], "suboptim": [73, 84], "subprocess": 4, "subsampl": 54, "subsect": 75, "subsequ": [9, 15, 75, 77, 81, 82, 84, 86, 87, 88], "subset": [1, 14, 38, 46, 53, 54, 59, 60, 63, 64, 72, 76, 78, 81, 82, 84, 86, 87], "substanti": 88, "substitut": [7, 92], "substructur": 76, "subtl": 77, "subtli": 35, "subtract": [31, 41, 54, 73, 78, 87], "subtract_background": 41, "succe": 78, "success": [16, 18, 73, 74, 75, 76, 82, 83, 86, 87, 96], "successfulli": [75, 83], "sudo": 91, "suffic": [53, 59, 60], "suffici": [1, 7, 40, 78, 83, 85, 87], "suffix": [33, 40], "suggest": [73, 74, 76, 79, 81, 82, 83, 85, 86, 88], "suit": [7, 44, 48], "suitabl": [1, 15, 44, 53, 59, 60, 63, 72, 74, 75, 82, 85, 86, 87, 88, 96], "sum": [1, 3, 6, 18, 29, 40, 44, 51, 54, 55, 63, 74, 81, 82, 83, 84, 85, 86, 87], "sum_": 55, "summari": [0, 12, 33, 65, 76, 81, 82, 83, 84, 85, 86, 87, 88, 96], "summaris": [3, 74, 96], "summary_t": 18, "summat": [1, 35, 40, 54, 63, 74, 81, 82, 83, 84, 85, 86], "super": 4, "supercel": 81, "superpos": 77, "suppli": [14, 52, 53, 54, 59, 60, 63, 75], "support": [0, 4, 7, 11, 43, 44, 45, 51, 52, 53, 55, 59, 60, 70, 71, 79, 90], "sure": [9, 72, 73, 74, 77, 78, 87], "surfac": [1, 15, 35, 81, 82, 86, 87, 88], "surface_weight": [1, 63], "survei": 97, "suspect": [77, 78], "sutton": [11, 95], "sv_refin": 81, "svn": 9, "sweep": [1, 15, 63, 72, 76, 79, 82, 83, 85, 86, 88, 89, 96], "sweep00": 76, "sweep1": 79, "sweep30": 76, "switch": [7, 18, 76, 81, 83, 85], "sxd": 94, "sy": [4, 83], "sym": 18, "sym_op": 18, "sym_op_scor": 18, "sym_ops_t": 18, "symbol": [2, 12, 53, 84, 85], "symm": [37, 73], "symmetr": [1, 40, 69, 73, 76, 82, 84, 85, 86, 88], "symmetri": [1, 11, 15, 19, 32, 37, 40, 44, 53, 59, 60, 63, 68, 70, 71, 72, 75, 76, 80, 81, 83, 95], "symmetris": 18, "symmetry_bas": [18, 19], "symmetryanalysi": [18, 19], "symmetryhandl": 11, "symop": 78, "symop_threshold": 37, "synaptotagmin": 95, "synch": 84, "synchrotron": [74, 78, 90, 94, 96, 97], "syntax": [1, 74], "synthesi": 83, "synthet": [35, 85], "synuclein": 95, "sys_absent_threshold": 53, "system": [0, 2, 7, 33, 54, 74, 75, 76, 79, 82, 86, 95], "system_phil": 33, "systemat": [1, 40, 68, 69, 72, 77, 78, 79, 81, 82, 84, 86, 87], "systematic_abs": 69, "s\u00fcdhof": 95, "t": [1, 2, 15, 22, 23, 25, 26, 29, 33, 35, 38, 40, 71, 73, 74, 75, 76, 81, 82, 83, 86, 87, 95], "t0": [82, 86], "t1": 78, "ta": 95, "tab": [71, 76, 84, 87], "tabl": [1, 2, 3, 4, 14, 15, 16, 33, 35, 38, 46, 47, 54, 57, 59, 60, 63, 65, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 87], "tabul": 35, "tailor": 16, "takanori": 0, "take": [4, 15, 17, 18, 38, 40, 46, 48, 52, 53, 54, 58, 59, 60, 63, 69, 74, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 93, 95], "taken": [1, 35, 53, 57, 59, 60, 62, 75, 76, 82, 83, 84, 86, 87, 88], "tale": 78, "talk": 0, "tandem": 97, "tanh": [43, 72], "tantalis": 97, "tape": 54, "tar": [7, 48, 75, 76, 78, 85, 86, 87, 88, 91], "tara": 0, "target": [1, 11, 14, 15, 18, 19, 53, 59, 60, 63, 70, 73, 74, 81, 82, 84, 86, 87], "target_angl": 11, "target_bravais_str": 11, "target_cycl": 63, "target_model": 63, "target_mtz": 63, "target_space_group": 11, "target_stil": 14, "target_symmetri": 11, "target_symmetry_primit": 11, "target_unit_cel": 11, "targetedoutlierreject": 15, "targetfactori": [14, 19], "tarik": 0, "task": [16, 54, 76, 82, 83, 86, 87], "tasklist": 83, "tasso": 97, "tau": 14, "tau2": 75, "tau3": 75, "tau_2": 75, "tau_3": 75, "tbc": 97, "tc": 95, "tchon": 0, "tcsh": 83, "technic": 97, "techniqu": 97, "technolog": 97, "technologi": 35, "teha": 83, "tell": [74, 77, 81, 83, 87, 93], "tem": 73, "tempel": [77, 78], "temperatur": [83, 95], "templat": [3, 21, 22, 23, 24, 25, 26, 29, 33, 52, 75, 79, 82, 83, 86, 87, 93], "ten": 76, "tend": [74, 75], "tendenc": 75, "term": [1, 2, 14, 53, 59, 60, 63, 73, 82, 86, 87, 88], "termin": [14, 18, 53, 59, 60, 63, 79, 81, 91], "termination_param": 18, "termination_paramet": 18, "terribl": 83, "terwillig": 95, "test": [1, 11, 14, 15, 18, 33, 37, 53, 61, 63, 69, 72, 75, 76, 78, 83, 84, 85, 87, 88], "test_for_termin": 14, "test_miller_set": 18, "test_objective_increasing_but_not_nref": 14, "test_rmsd_converg": 14, "tetragon": [76, 81], "text": [2, 24, 33, 35, 73, 74, 82, 83, 86, 87], "textrm": [76, 81], "tgz": 48, "th_8_2": 81, "th_8_2_": 79, "than": [1, 2, 7, 11, 18, 21, 38, 41, 46, 47, 51, 53, 54, 56, 58, 59, 60, 63, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 93, 96, 97], "thank": [77, 78, 83], "thaum_m10s15_3_": 81, "thaumatin": [79, 81], "thei": [2, 9, 11, 14, 16, 18, 38, 46, 47, 53, 54, 59, 60, 73, 74, 75, 76, 78, 81, 82, 86, 87, 97], "them": [4, 16, 25, 38, 46, 59, 73, 74, 75, 76, 78, 81, 82, 83, 86, 87, 93, 96], "themselv": [1, 23], "theoret": 84, "theori": [77, 92], "therefor": [1, 4, 14, 53, 59, 60, 73, 82, 83, 84, 86, 88], "thereof": 54, "thermofish": 73, "theta": [23, 88], "thi": [0, 1, 2, 3, 4, 6, 7, 9, 11, 14, 15, 16, 18, 21, 23, 24, 25, 29, 33, 34, 35, 36, 37, 38, 40, 41, 42, 43, 44, 46, 47, 48, 50, 51, 52, 53, 54, 55, 56, 58, 59, 60, 61, 63, 66, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 92, 93, 94, 95, 96, 97], "thick": [23, 35, 52, 53, 54, 59, 60, 82, 86], "thin": [1, 18, 72], "thing": [4, 6, 42, 73, 81, 83, 84, 97], "think": [2, 78, 83, 97], "third": [0, 1, 9, 52, 73], "thompson": 0, "thomson": 73, "thorn": 95, "thorough": 77, "those": [0, 7, 9, 14, 33, 40, 49, 53, 59, 60, 66, 70, 73, 74, 76, 77, 82, 83, 84, 86, 87, 88], "though": [7, 73, 74, 76, 81, 82, 83, 84, 86, 88], "thought": [77, 78], "three": [1, 2, 3, 11, 53, 57, 59, 60, 62, 73, 74, 76, 82, 84, 86, 87, 90, 97], "threshold": [1, 15, 16, 31, 37, 38, 40, 41, 44, 45, 47, 51, 54, 58, 69, 70, 72, 73, 74, 75, 78, 82, 84, 86, 87], "threshold_funct": 16, "threshold_prob": [53, 59, 60], "through": [0, 1, 14, 23, 35, 63, 73, 74, 76, 77, 78, 82, 83, 84, 86, 87, 88, 97], "throughout": [2, 81, 84], "throughput": 48, "throw": [38, 47], "thrown": 81, "thu": [74, 82, 83, 86, 87], "thygesen": 74, "ti": 74, "tick": [74, 87], "tie": [53, 59, 60], "tie_to_group": [53, 59, 60], "tie_to_target": [53, 59, 60, 74, 75], "tiff": 45, "tight": 87, "tightli": 95, "tile": [80, 82, 86, 87], "tilt": 73, "time": [2, 4, 16, 24, 26, 33, 46, 63, 73, 75, 76, 77, 81, 82, 83, 84, 85, 86, 87, 94, 95, 97], "timepix": [74, 75], "timer": 33, "timestamp": [52, 96], "tini": [12, 26], "tiny_int_2": 12, "tir": [74, 80], "titl": [33, 73, 84, 85], "tl": 95, "tmp": 79, "tmp4xxusn": 79, "to_cryst": [27, 30], "to_dict": [15, 22, 23, 24, 25], "to_imageset": [27, 30], "to_json_fil": 14, "to_shelx": [73, 88], "to_xd": [27, 30], "todai": 97, "tof": 94, "tofspotfind": [16, 19], "togeth": [1, 2, 63, 72, 74, 75, 76, 81, 83, 97], "toggl": [4, 76, 82, 86], "token": 23, "toler": [11, 18, 38, 41, 44, 51, 53, 54, 58, 63, 72, 75, 83, 88], "toll": 74, "tom": 97, "too": [14, 40, 53, 59, 60, 74, 78, 81, 82, 83, 84, 86, 87], "took": [79, 81, 83], "tool": [76, 77, 78, 82, 84, 86, 87, 89, 90], "toolbox": [2, 95], "toolkit": [7, 38, 78, 83, 94, 95], "top": [4, 12, 73, 74, 78], "topic": 78, "tort": 92, "total": [11, 14, 47, 49, 74, 76, 79, 81, 82, 83, 84, 86, 87, 88], "total_intens": 49, "total_reflect": [41, 51, 54, 58], "touch": 76, "toward": [1, 73, 74, 81, 97], "toxic": 95, "tp": [79, 85], "traceback": 33, "track": [14, 53, 59, 60, 76, 78, 82, 86, 87], "track_condition_numb": [53, 59, 60], "track_gradi": [53, 59, 60], "track_jacobian_structur": [53, 59, 60], "track_normal_matrix": [53, 59, 60], "track_out_of_sample_rmsd": [53, 59, 60], "track_parameter_correl": [53, 59, 60, 83], "track_step": [53, 59, 60], "trade": [53, 59, 60], "train": [84, 86, 87], "tran": 95, "transduct": 74, "transfer": 0, "transform": [2, 11, 39, 53, 60, 85, 87, 88], "transit": 77, "translat": [30, 53, 59, 60, 77, 82, 84, 86], "transmiss": [21, 52, 82, 86], "treat": [53, 59, 60, 76, 81, 93], "treat_single_image_as_stil": [53, 59, 60], "treatment": 84, "tree": [83, 87], "trek": 97, "tri": [33, 47], "tricki": 76, "triclin": [60, 70, 74, 75, 82, 86, 87, 88], "trigger": [53, 59, 60, 63], "trim": [53, 59, 60, 73], "trim_scan_to_observ": [53, 59, 60], "triplet": 53, "trivial": [4, 78], "trivial_accessor": [10, 12, 25, 26], "troubleshoot": 78, "trough": [86, 87], "trp_ag_": 85, "true": [1, 2, 4, 6, 11, 14, 15, 16, 18, 21, 22, 23, 24, 25, 26, 29, 30, 31, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72, 73, 75, 77, 81, 82, 83, 84, 86, 87, 93], "truncat": [18, 53, 54, 59, 60, 82, 84, 85, 86], "trunccauchy_pdf": [18, 19], "trunk": 9, "trust": [0, 47, 50, 52, 74, 78], "trusted_rang": [3, 23, 52, 82, 86], "trustworthi": [46, 82, 86, 87], "truth": 83, "try": [1, 4, 7, 24, 33, 63, 73, 74, 76, 77, 78, 79, 81, 82, 83, 86, 96], "try_read_experi": 33, "try_read_experiments_from_imag": 33, "try_read_reflect": 33, "trypsin": 85, "tsai": 95, "tukei": [53, 54, 59, 60, 81, 82, 83, 85, 86, 87], "tune": [54, 82, 86, 87], "tuning_const": 54, "tupl": [4, 11, 14, 15, 16, 18, 21, 22, 23, 25, 26, 33, 53, 59, 60, 83], "turn": [1, 2, 11, 25, 53, 54, 59, 60, 63, 73, 76, 78, 81, 82, 83, 86, 87], "tutori": [1, 7, 8, 74, 75, 76, 77, 78, 79, 81, 83, 84, 93], "tutorial_data": [81, 86], "tw": 74, "tweak": 85, "twice": [53, 59, 60, 82, 86, 87], "twin": [18, 61, 76, 79], "twist": 74, "two": [1, 2, 3, 4, 15, 18, 23, 35, 39, 52, 53, 59, 60, 64, 66, 73, 74, 76, 77, 78, 82, 86, 87, 88], "two_theta": [23, 72], "two_theta_angl": 23, "two_theta_direct": 23, "two_theta_refin": [71, 72, 76, 88], "two_theta_refine_2theta": 76, "tyoe": 33, "type": [1, 3, 4, 6, 7, 11, 14, 15, 17, 18, 22, 23, 24, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72, 74, 79, 82, 83, 84, 85, 86, 87, 91], "typic": [1, 2, 7, 11, 35, 47, 48, 53, 54, 59, 60, 63, 66, 69, 72, 74, 78, 81, 82, 86, 87, 88], "u": [2, 4, 35, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 95], "u_0": 2, "u_cif": 84, "ub": [2, 74, 81, 82, 85, 86, 88, 95], "ub_matrix": 3, "uc_abs_angle_toler": 22, "uc_rel_length_toler": 22, "uctbx": [2, 11, 22], "uervirojnangkoorn": 95, "uhlig": 95, "uk": [0, 91, 99], "ultim": 77, "un": 35, "unabl": [82, 86], "uncertainti": [1, 40, 53, 72, 75, 82, 84, 86, 87, 88], "unclear": 2, "uncom": 83, "unconstrain": 88, "unconvent": 77, "uncorrect": [63, 81, 82, 84, 86, 87], "under": [0, 7, 15, 47, 48, 82, 83, 86, 87, 90], "undergon": 77, "underli": 96, "understand": [78, 82, 85, 86, 87, 97], "understood": 87, "underwai": [81, 94], "unequ": [82, 86, 87], "unexpect": 84, "unfeas": 44, "unfortun": [2, 78, 81, 83, 84], "unhandl": [24, 33, 52], "unicod": [2, 75], "uniform": [82, 86, 87], "unindex": [53, 54, 73, 74, 78, 82, 85, 86, 87], "unindexed_reflect": 11, "unintegr": [54, 82, 86], "uniq": [73, 82, 84, 85, 86], "uniqu": [24, 52, 53, 63, 72, 74, 76, 79, 82, 84, 85, 86, 87, 88], "unit": [2, 11, 18, 22, 33, 40, 41, 44, 45, 46, 47, 50, 51, 53, 54, 56, 57, 58, 59, 60, 63, 70, 72, 73, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 92, 96], "unit_cel": [2, 11, 22, 33, 41, 44, 45, 46, 47, 50, 51, 53, 54, 58, 59, 60, 63, 72, 73, 74, 75, 77, 78, 81, 82, 85, 86, 96], "unit_cell_clust": [40, 72], "unit_s0": 21, "uniti": [63, 78], "univers": [2, 11], "unknown": [2, 26, 44], "unless": [1, 7, 21, 33, 53, 59, 60, 63, 72, 74], "unlik": 88, "unmerg": [1, 43, 44, 72, 73, 74, 79, 83, 84, 87, 98], "unmerged_mtz": [1, 63], "unpack": [7, 75], "unphys": [41, 51, 54, 58, 82, 86], "unpolar": 21, "unrealist": 53, "unreason": 74, "unrecognis": 78, "unrel": [82, 86], "unscal": [15, 44, 75, 78, 82, 86, 87], "unsign": [10, 12, 14, 24, 25, 26], "unstabl": [1, 63], "unsuccess": 83, "untick": 87, "until": [11, 14, 53, 59, 60, 73, 77, 78, 81, 82, 86, 87], "untrust": [47, 50, 51, 73, 75], "unus": 59, "unusu": [75, 83], "unwant": 50, "unwarp": 78, "unweight": 14, "unwieldi": 83, "up": [1, 7, 11, 14, 15, 24, 40, 42, 53, 54, 59, 60, 66, 68, 73, 74, 75, 77, 81, 82, 83, 84, 86, 87, 91, 96, 97], "updat": [9, 14, 15, 33, 44, 53, 59, 63, 81, 82, 83, 85, 86, 87, 98], "update_analysi": 11, "update_detector_px_mm_data": 26, "update_journ": 14, "update_match": 14, "upon": [15, 76], "upper": [18, 54, 63, 72, 87], "upper_bound": 18, "uptick": 73, "us": [0, 2, 3, 4, 7, 9, 11, 12, 14, 15, 16, 18, 21, 22, 23, 24, 25, 26, 29, 33, 34, 35, 37, 38, 40, 41, 42, 44, 45, 46, 47, 48, 50, 51, 52, 53, 54, 55, 58, 59, 60, 61, 62, 63, 64, 66, 69, 70, 71, 73, 74, 75, 76, 77, 78, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97], "usa": [0, 2, 35], "usag": [6, 7, 63, 72, 83, 88], "use_al": [1, 63, 72], "use_all_reflect": 81, "use_beam_refer": 52, "use_curvatur": [18, 40, 72], "use_dataman_shel": 72, "use_dataset": 63, "use_detector_refer": 52, "use_dynamic_mask": 54, "use_free_set": 63, "use_gonio_refer": 52, "use_internal_vari": 63, "use_lattice_symmetri": 72, "use_p1_indices_as_se": 53, "use_starting_angl": 68, "used_in_index": 4, "used_in_refin": [14, 46], "useless": [78, 83], "user": [2, 4, 7, 11, 14, 36, 46, 47, 48, 54, 63, 78, 79, 80, 82, 83, 84, 86, 87, 90, 91], "usernam": 9, "usr": [7, 91], "usual": [2, 14, 41, 42, 47, 72, 73, 74, 78, 79, 81, 82, 83, 86, 87, 88, 93], "util": [6, 12, 14, 32, 35, 38, 48, 71, 83], "utilis": 97, "uuid": 52, "v": [1, 2, 7, 43, 53, 59, 60, 72, 73, 80, 82, 86, 87, 95, 96, 97], "v5": 44, "v5_next": 44, "vajjhala": 74, "valid": [12, 14, 15, 26, 33, 48, 49, 53, 54, 59, 60, 63, 84, 85], "valid_foreground_threshold": [12, 54], "valu": [1, 3, 7, 10, 11, 14, 15, 18, 33, 35, 40, 41, 42, 43, 44, 46, 47, 48, 51, 52, 53, 54, 55, 57, 58, 59, 60, 63, 65, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 96], "valuabl": 73, "value_max": [15, 40, 43, 44, 45, 46, 47, 52, 53, 54, 59, 60, 63, 69, 72], "value_min": [15, 38, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 58, 59, 60, 62, 63, 64, 67, 68, 69, 70, 72], "valueerror": [15, 33], "van": [53, 59, 60, 95], "var": 14, "vari": [1, 14, 17, 41, 44, 51, 53, 54, 57, 58, 59, 60, 73, 74, 81, 82, 83, 85, 86, 87, 88, 93], "variabl": [2, 52, 63, 74, 75, 81, 87], "varianc": [1, 3, 15, 40, 45, 47, 51, 54, 63, 72, 76, 82, 84, 86, 87], "variat": [73, 82, 83, 84, 86, 87, 88], "varieti": 84, "variou": [1, 2, 11, 14, 43, 44, 52, 53, 60, 62, 63, 72, 74, 75, 82, 86, 87, 91, 94], "ve": [22, 74, 76], "vec": 2, "vec2": 23, "vec3": [22, 23, 25], "vec3_doubl": [4, 11, 25], "vector": [1, 2, 3, 6, 11, 14, 18, 21, 23, 34, 35, 40, 52, 53, 77, 82, 83, 84, 86, 87], "vectori": 2, "vendor": 26, "venugopalan": 95, "verbos": [33, 48, 53, 59, 60, 82, 86, 96], "veri": [1, 35, 73, 74, 76, 78, 81, 82, 83, 84, 86, 87, 88], "verifi": [6, 24], "versa": 14, "version": [7, 14, 35, 44, 48, 49, 75, 79, 81, 84, 87], "versu": [77, 82, 86, 87], "vertic": [2, 54, 78], "via": [0, 2, 4, 9, 45, 55, 76, 87, 88, 90], "view": [4, 40, 47, 51, 74, 75, 77, 78, 82, 86, 87, 88, 95, 97], "viewer": [2, 73, 74, 75, 77, 78, 81, 82, 86, 87, 88], "viewhkl": 73, "vinetski": 95, "virtual": 44, "virtual_fram": 44, "visibl": [76, 82, 86, 87], "visit": 48, "viz": [53, 59, 60, 88], "vk": 95, "vmxi": 84, "vmxi_proteinase_k_sweep": 84, "void": [10, 12, 14, 22, 23, 24, 25, 26], "vollmar": 95, "volum": [11, 41, 43, 51, 53, 54, 58, 59, 60, 72, 73, 74, 76, 77, 78, 82, 83, 84, 85, 86, 87, 88, 97], "volume_cutoff": [11, 53], "volume_weight": [11, 53], "vondelft": 97, "voxel": 53, "voxel_grid_point": 53, "vv": 96, "w": [0, 2, 11, 14, 15, 95], "w_": 18, "wa": [2, 7, 14, 15, 47, 53, 59, 60, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88], "wagner": 95, "wai": [2, 33, 73, 74, 77, 78, 79, 81, 82, 83, 84, 92, 93, 94, 96], "wait": 73, "wakatsuki": 95, "wall": 95, "walsh": 95, "wander": 74, "wang": 73, "want": [1, 48, 73, 74, 77, 78, 81, 82, 83, 84, 86, 87, 88], "ward": 53, "warn": [77, 78, 83, 84, 86], "warn_if_setting_unused_refinement_protocol_param": 11, "warrant": 84, "warranti": 92, "wast": 97, "water": 95, "waterman": [0, 11, 73, 75, 95, 97, 98], "wave": 11, "wavelength": [3, 6, 18, 21, 22, 33, 38, 44, 52, 53, 59, 60, 63, 72, 73, 74, 75, 79, 82, 84, 85, 86, 88], "wavelength_rang": [21, 52], "wavelength_spread": [41, 51, 54, 58], "wavelength_toler": [24, 33, 44, 72], "wavelengthgroup": [32, 33], "we": [0, 2, 4, 7, 11, 14, 16, 21, 25, 26, 33, 35, 37, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 91, 93, 94, 95, 96, 97], "weak": [1, 75, 77, 78, 79, 84, 96], "weaker": [73, 77], "weakli": [63, 81], "weatherbi": 95, "web": [48, 71, 73], "webber": 0, "webpag": 48, "webserv": 48, "wedg": [1, 11, 53, 80, 83, 87], "weekend": 0, "wei": 95, "weight": [10, 11, 14, 15, 18, 40, 53, 59, 60, 63, 72, 81, 82, 83, 86], "weighted_mean": 33, "weighting_schem": 63, "weighting_strategi": [14, 53, 59, 60], "weighting_strategy_overrid": 14, "welcom": [0, 83], "well": [11, 29, 44, 57, 62, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 87], "wellcom": [0, 90], "weng": 95, "were": [4, 11, 14, 38, 48, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88], "wernet": 95, "west": [90, 99], "westbrook": 2, "wget": [9, 48, 91], "what": [2, 14, 23, 72, 74, 76, 77, 78, 82, 85, 86, 87, 97], "whatev": [78, 82, 83, 86, 87], "wheel": 0, "when": [1, 2, 9, 11, 14, 15, 18, 25, 26, 33, 35, 38, 44, 47, 50, 51, 52, 53, 54, 59, 60, 63, 66, 69, 70, 72, 73, 75, 76, 77, 78, 79, 82, 83, 84, 86, 87, 93, 96], "whenev": 4, "where": [1, 2, 4, 7, 11, 14, 15, 18, 21, 23, 24, 25, 26, 29, 35, 38, 40, 43, 44, 47, 49, 52, 53, 54, 55, 59, 60, 63, 66, 69, 72, 74, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 91], "wherea": [47, 63, 74, 81, 82, 86, 87], "whether": [1, 4, 14, 15, 18, 33, 38, 47, 51, 53, 54, 57, 59, 60, 62, 63, 65, 69, 72, 82, 83, 86, 87, 92], "which": [0, 1, 2, 4, 7, 11, 14, 15, 18, 21, 22, 23, 25, 29, 33, 35, 37, 38, 40, 42, 43, 44, 46, 47, 48, 50, 51, 52, 53, 54, 57, 59, 60, 61, 62, 63, 65, 70, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 91, 93, 96], "while": [1, 2, 9, 14, 38, 53, 66, 74, 75, 81, 82, 83, 84, 86, 87, 88], "whilst": [2, 3, 53, 59, 60, 83], "white": [94, 95, 97], "whitelegg": 95, "who": [0, 7], "whole": [1, 4, 47, 50, 51, 53, 59, 60, 63, 72, 76, 78, 81, 82, 83, 86, 87], "whose": [2, 47, 50, 51, 53, 54, 59, 60], "why": [82, 86, 97], "wi": 95, "wide": [1, 7, 47, 51, 53, 64, 74, 76, 84], "wide_search_bin": [53, 64], "wider": [53, 59, 60], "width": [12, 14, 15, 18, 38, 46, 47, 50, 51, 53, 59, 60, 66, 75, 81, 82, 86, 87], "wiki": [7, 9, 18], "wikipedia": 18, "wildcard": 87, "william": [0, 95], "wilson": [40, 73, 79, 82, 84, 86], "window": [7, 73, 75, 78, 87, 91], "winn": 79, "winter": [0, 11, 18, 40, 79, 84, 95, 97, 98], "wish": [0, 88], "within": [0, 1, 2, 4, 7, 14, 37, 47, 50, 51, 52, 53, 58, 59, 60, 63, 66, 72, 74, 79, 81, 82, 83, 84, 86, 87, 88, 90, 97], "within_spot_sigma": 54, "without": [3, 7, 33, 76, 78, 81, 83, 87, 88, 92, 93], "wj": 73, "wl": 33, "wojdyr": 0, "wolfgang": 97, "wolfram": [77, 78], "won": [74, 76, 81], "word": 78, "work": [0, 2, 4, 7, 9, 11, 14, 21, 25, 33, 53, 54, 59, 60, 63, 73, 74, 76, 77, 78, 79, 81, 83, 84, 86, 87, 88, 90, 93, 94, 97], "workaround": 81, "workshop": [0, 11, 86, 87], "worri": [78, 81, 87], "worrisom": 84, "wors": [77, 81, 82, 83, 84, 86, 87], "worsen": 86, "worst": 45, "worth": [76, 78, 82, 83, 84, 85, 86, 87], "would": [1, 7, 15, 53, 59, 60, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 93, 97], "wp6": 97, "wrap": [29, 96, 97], "wrapper": 18, "write": [3, 7, 33, 40, 44, 46, 47, 53, 59, 60, 70, 74, 77, 78, 81, 82, 83, 84, 85, 86, 87, 96], "write_column": [32, 33], "write_hot_mask": [16, 47], "write_hot_pixel_mask": 16, "writer": 33, "written": [0, 2, 7, 44, 45, 52, 74, 82, 83, 85, 86, 92], "wrong": [14, 74, 78, 81, 82, 86], "wrongli": 78, "wrt": 2, "www": [18, 48], "wx": 14, "wxtbx": 33, "wy": 14, "wz": 14, "x": [1, 2, 11, 14, 18, 21, 22, 23, 25, 33, 35, 40, 43, 47, 50, 51, 52, 53, 59, 60, 61, 63, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 87, 90, 91, 94, 95, 97], "x0": [47, 50, 51], "x0692": 82, "x0692_1_": 82, "x0692_1_0": 82, "x1": [47, 50, 51], "x212b": [2, 75], "x247398": 78, "x86_64": [7, 91], "xaamdi": 35, "xc": [47, 50, 51, 81, 82, 83, 86], "xchem": 82, "xd": [0, 22, 24, 30, 44, 53, 78, 81, 82, 86, 87, 97], "xdg": 74, "xds_ascii": [30, 44], "xds_detector_nam": [27, 30], "xds_inp": [24, 30], "xds_other": 24, "xfel": 90, "xia": 76, "xia2": [30, 71, 73, 80, 82, 86, 88, 95], "xjf": [7, 91], "xml": [49, 54], "xo": [81, 82, 83, 86], "xparm": [30, 33, 44], "xparm_xd": 30, "xprep": [70, 73, 88], "xrai": 21, "xscale": [1, 44], "xta": 83, "xta30_1_": 83, "xta31_1_": 83, "xtal": [44, 63, 83, 84, 85], "xtal7_1_": 83, "xtal8_1_": 83, "xtal_height_above_kapton_mm": 54, "xu": 74, "xvf": 78, "xy": [82, 86], "xycorr": 30, "xyz": 18, "xyzcal": 3, "xyzob": [3, 14], "xz": [7, 44, 76, 91], "xzf": 91, "y": [1, 2, 11, 14, 18, 21, 22, 23, 25, 40, 43, 47, 50, 51, 52, 53, 59, 60, 61, 63, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 87, 95], "y0": [47, 50, 51], "y1": [47, 50, 51], "yachandra": 95, "yano": 95, "yc": [47, 50, 51, 81, 82, 83, 86], "yd": 22, "year": [90, 97], "yellow": 73, "yet": [81, 82, 83, 86, 87], "yield": 88, "yilmaz": 83, "yo": [81, 82, 83, 86], "yoon": 74, "you": [1, 4, 7, 9, 23, 40, 48, 54, 71, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 91, 97], "young": [0, 95], "your": [4, 7, 9, 35, 48, 73, 76, 77, 79, 82, 83, 84, 86, 87, 88, 93], "yourself": 76, "z": [14, 18, 21, 22, 23, 25, 33, 40, 43, 61, 63, 73, 76, 78, 82, 84, 86, 87, 90], "z_cc": 18, "z_cc_against": 18, "z_cc_for": 18, "z_cc_net": 18, "z_score": 84, "zadvornyi": 95, "zatsepin": 74, "zcc": [18, 40, 73, 76, 82, 84, 85, 86, 87], "zeldin": [0, 95], "zenodo": [82, 88], "zero": [1, 2, 11, 35, 47, 53, 54, 59, 60, 63, 66, 69, 70, 73, 81], "zerr": 73, "zeta": [41, 51, 54, 58, 82, 86, 87], "zhang": 95, "zhao": [74, 95], "zhou": 95, "zhu": 95, "zinger": [73, 83], "zlib": 45, "zmax": 15, "zone": [11, 58, 74], "zoo": 76, "zoom": [73, 74, 76, 77, 82, 86], "zou": 74, "zouni": 95, "zwart": 95, "\u00b2": [82, 84, 86], "\u00b5m": 74, "\u00e5": [6, 21, 73, 74, 76, 82, 84, 86, 87, 95], "\u00e5ngstr\u00f6m": 74, "\u03b1": [74, 95], "\u03b2": [40, 72, 74], "\u03b3": 74, "\u03b4": [40, 72, 87], "\u03b4cc\u00bd": [63, 72, 74, 76, 84], "\u03b4f": 84, "\u03ba": 2, "\u03c3": [40, 72, 82, 84, 86], "\u03c3\u00b2": [82, 84, 86], "\u03c6": [2, 82, 86, 87], "\u03c9": 2, "\u2460": [82, 86], "\u2461": [82, 86], "\u2462": [82, 86], "\ud835\udfd9": 2}, "titles": ["About", "User guide for scaling data with DIALS", "Conventions", "Data files", "Extending DIALS", "Developer Examples", "Reading experiment and data", "Getting started", "Documentation", "Installation for Developers", "dials.algorithms.background", "dials.algorithms.indexing", "dials.algorithms.integration", "dials.algorithms.profile_model", "dials.algorithms.refinement", "dials.algorithms.scaling", "dials.algorithms.spot_finding", "dials.algorithms.spot_prediction", "dials.algorithms.symmetry", "Algorithms", "Array Family", "dxtbx.model.beam", "dxtbx.model.crystal", "dxtbx.model.detector", "dxtbx.model.experiment_list", "dxtbx.model.goniometer", "dxtbx.imageset", "dxtbx", "dxtbx.model.profile", "dxtbx.model.scan", "dxtbx.serialize", "Extensions", "Library Reference", "Util", "dials.align_crystal", "dials.anvil_correction", "dials.apply_mask", "dials.check_indexing_symmetry", "dials.combine_experiments", "dials.compare_orientation_matrices", "dials.cosym", "dials.create_profile_model", "dials.estimate_gain", "dials.estimate_resolution", "dials.export", "dials.export_bitmaps", "dials.filter_reflections", "dials.find_spots", "distl/dials apache server", "dials.find_spots_server/client", "dials.generate_mask", "dials.image_viewer", "dials.import", "dials.index", "dials.integrate", "dials.merge_cbf", "dials.missing_reflections", "dials.plot_scan_varying_model", "dials.predict", "dials.refine", "dials.refine_bravais_settings", "dials.reindex", "dials.report", "dials.scale", "dials.search_beam_position", "dials.show", "dials.slice_sequence", "dials.spot_counts_per_image", "dials.stereographic_projection", "dials.symmetry", "dials.two_theta_refine", "Program documentation", "xia2.multiplex", "Processing Small Molecule MicroED/3DED: Biotin", "MyD88TIR small wedges", "Lysozyme nanocrystals", "Multi-crystal analysis with DIALS and xia2.multiplex", "DPF3 Part 2: A question of centring", "DPF3 Part 1: Correcting poor initial geometry", "Using DIALS at Diamond Light Source", "Tutorials", "Refining multi-tile detector metrology with DIALS", "SARS-CoV-2 main protease (Mpro)", "Multi-crystal analysis with DIALS and BLEND: individual vs joint refinement", "Multi-crystal symmetry analysis and scaling with DIALS", "Multi-lattice Tutorial", "Processing in Detail", "Processing in Detail with DUI", "Small-molecule data reduction tutorial", "DIALS How-To guides", "DIALS: Diffraction Integration for Advanced Light Sources", "Installation", "DIALS License", "Processing Sequences with Missing Images", "Projects", "Publications", "SSX processing guide", "DIALS 1: 12th-13th June 2012 (Diamond Light Source, UK)", "DIALS-3: 22nd May 2013 (Cambridge, UK)", "Workshops"], "titleterms": {"0": [76, 91], "1": [75, 78, 97], "10": 76, "12th": 97, "13th": 97, "18": [], "19": 76, "2": [75, 77, 82], "20": [76, 91], "2012": 97, "2013": 98, "22nd": 98, "29": 76, "3": [75, 91, 98], "3ded": 73, "4": 75, "5": 75, "6": 75, "7": 75, "9": 76, "A": 77, "No": 9, "The": 2, "To": 89, "about": [0, 73], "acknowledg": [0, 77, 78, 81, 83], "ad": 4, "advanc": [1, 90], "against": 1, "algorithm": [10, 11, 12, 13, 14, 15, 16, 17, 18, 19], "align_cryst": 34, "almost": 84, "altern": 88, "analysi": [74, 76, 82, 83, 84, 86], "anvil_correct": 35, "apach": 48, "appli": 81, "applic": 95, "apply_mask": 36, "arrai": 20, "articl": 95, "attende": 98, "axi": 74, "background": 10, "bad": 73, "basi": 4, "basic": [34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "basis_vector_search": 11, "beam": [21, 73, 78], "better": 78, "binari": 91, "biotin": 73, "blend": 83, "bookkeep": 76, "bravai": [73, 82, 86, 87, 88], "build": [48, 91], "built": 7, "cambridg": 98, "case": [43, 72], "cc": 76, "cell": [76, 88], "center": 73, "centr": [73, 77, 78], "check": [78, 87], "check_indexing_symmetri": 37, "choos": 1, "class": 4, "client": 49, "cluster": 76, "collect": 73, "combine_experi": 38, "committe": 97, "common": 1, "compare_orientation_matric": 39, "comparison": 76, "conclus": [77, 78], "contact": 90, "content": [4, 20, 31], "control": 1, "convent": 2, "convert": 77, "coordin": 2, "correct": [73, 78, 81], "cosym": [18, 40], "cov": 82, "create_profile_model": 41, "crystal": [22, 76, 83, 84], "crystallographi": 95, "current": 9, "data": [1, 3, 6, 9, 73, 74, 75, 76, 82, 86, 87, 88, 96], "dataset": [1, 73, 75, 83], "defin": 4, "definit": [34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "delta": 76, "detail": [35, 86, 87], "detector": [23, 74, 81], "determin": [73, 74, 88], "develop": [0, 5, 9, 91], "dial": [0, 1, 4, 7, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 76, 79, 81, 83, 84, 89, 90, 91, 92, 94, 95, 96, 97, 98], "diamond": [79, 97], "diffract": [90, 94], "diffractomet": 2, "discov": 78, "distanc": 74, "distl": 48, "do": [81, 83], "document": [8, 71], "download": 9, "dpf3": [77, 78], "dui": 87, "dxtbx": [2, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30], "east": 0, "entri": 4, "environ": [7, 9], "equat": 2, "estimate_gain": 42, "estimate_resolut": 43, "exampl": [5, 40, 43, 72], "exclud": 73, "experi": [3, 6, 76], "experiment": 78, "experiment_list": 24, "explor": 76, "exploratori": 74, "export": [44, 73, 82, 86, 87, 88, 93], "export_bitmap": 45, "extend": 4, "extens": 31, "famili": 20, "feedback": 79, "file": 3, "filter_reflect": 46, "find": [73, 74, 75, 78, 82, 86, 87, 88], "find_spot": 47, "find_spots_serv": 49, "format": 4, "frame": [2, 73], "full": [34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "fund": 90, "further": 74, "gener": [73, 79], "generate_mask": 50, "geometri": [73, 78], "get": 7, "gltbx_gl_ext": 9, "goniomet": [2, 25], "graphic": 91, "guid": [1, 89, 96], "half": 76, "help": 7, "how": 89, "html": [82, 86], "imag": [73, 93], "image_view": 51, "imageset": 26, "import": [52, 73, 75, 78, 82, 85, 86, 87, 88, 93], "index": [4, 11, 53, 73, 74, 75, 78, 82, 85, 86, 87, 88, 96], "individu": 83, "initi": 78, "inspect": 87, "instal": [7, 9, 91], "instruct": 48, "integr": [12, 54, 73, 74, 75, 82, 85, 86, 87, 88, 90, 96], "intens": 76, "introduct": [34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88], "joint": 83, "jointli": 83, "journal": 95, "june": 97, "keep": 9, "laboratori": 2, "larg": 1, "lattic": [4, 73, 74, 77, 82, 85, 86, 87, 88], "lattice_search": 11, "librari": 32, "licens": 92, "light": [79, 90, 97], "linux": [9, 91], "list": 3, "lysozym": 75, "mac": [9, 91], "mai": 98, "main": 82, "manual": 84, "mask": 73, "matrix": 2, "max_cel": 11, "merg": [75, 82, 85, 86], "merge_cbf": 55, "method": 4, "metrologi": 81, "micro": 73, "minimis": 1, "miss": 93, "missing_reflect": 56, "model": [1, 2, 4, 15, 21, 22, 23, 24, 25, 28, 29, 75, 78], "model_evalu": 11, "modul": 9, "modulenotfounderror": 9, "molecul": [73, 88], "mpro": 82, "mtz": [82, 86, 87], "multi": [73, 76, 81, 83, 84, 85], "multiplex": [72, 76, 84], "myd88tir": 74, "name": 9, "nanocryst": 75, "neutron": 94, "new": 4, "newslett": 95, "next": [7, 81, 83], "note": 73, "offset": 73, "option": [1, 73], "organis": 97, "orient": [2, 74, 76], "orthogonalis": 2, "other": 73, "outlier_reject": 15, "output": 88, "paramet": [7, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "part": [77, 78], "path": 88, "pedest": 73, "plot_scan_varying_model": 57, "point": 4, "poor": 78, "post": 76, "practic": 1, "predict": 58, "preferenti": 76, "prepar": 81, "present": [97, 98], "process": [73, 74, 76, 83, 86, 87, 93, 96], "profil": [4, 28], "profile_model": 13, "program": [71, 97, 98], "project": 94, "proteas": 82, "pseudocentr": 77, "public": 95, "question": 77, "re": 73, "read": 6, "reciproc": 76, "reduct": 88, "refer": [1, 32], "refin": [14, 59, 73, 74, 75, 81, 82, 83, 85, 86, 87, 88, 93], "refine_bravais_set": 60, "reflect": [1, 3], "regress": 9, "reindex": 61, "releas": 91, "report": [62, 82, 86, 95], "reprocess": 84, "result": 87, "sadab": 88, "sar": 82, "scale": [1, 4, 15, 63, 73, 74, 75, 82, 84, 85, 86, 87, 88], "scan": [29, 75], "script": 74, "search": 4, "search_beam_posit": 64, "sequenc": 93, "serial": 30, "server": 48, "set": [9, 76], "show": 65, "slice_sequ": 66, "small": [73, 74, 88], "solv": 73, "sourc": [7, 79, 90, 97], "space": 76, "spot": [73, 74, 75, 78, 82, 86, 87, 88], "spot_counts_per_imag": 67, "spot_find": 16, "spot_predict": 17, "spotfind": 85, "ssx": 96, "ssx_index": 96, "ssx_integr": 96, "stabl": 91, "start": 7, "static": [4, 75], "step": 7, "stereographic_project": 68, "stills_index": 11, "strategi": 4, "structur": 73, "summari": 2, "symmetri": [18, 69, 73, 74, 77, 78, 82, 84, 85, 86, 87, 88], "synchrotron": 95, "tabl": [20, 31], "team": 0, "test": [9, 48], "tile": 81, "tilt": 74, "togeth": 73, "tutori": [80, 82, 85, 86, 87, 88], "two_theta_refin": 70, "uk": [97, 98], "understand": 4, "unit": [76, 88], "unmerg": [82, 86], "up": 9, "us": [1, 43, 72, 79], "user": 1, "util": 33, "v": 83, "vari": 75, "vector": 4, "video": 73, "wedg": 74, "west": 0, "what": [81, 83], "workshop": 99, "write": 4, "xfel": 95, "xia2": [72, 76, 79, 84]}}) \ No newline at end of file +Search.setIndex({"alltitles": {"About": [[0, "about"]], "Acknowledgements": [[0, "acknowledgements"], [77, "acknowledgements"], [78, "acknowledgements"], [81, "acknowledgements"], [83, "acknowledgements"]], "Adding new format classes": [[4, "adding-new-format-classes"]], "Advanced use - Choosing reflections to use for minimisation": [[1, "advanced-use-choosing-reflections-to-use-for-minimisation"]], "Advanced use - Controlling the scaling models": [[1, "advanced-use-controlling-the-scaling-models"]], "Algorithms": [[19, "algorithms"]], "Almost there": [[84, "almost-there"]], "Analysis of individually processed datasets": [[83, "analysis-of-individually-processed-datasets"]], "Analysis of jointly refined datasets": [[83, "analysis-of-jointly-refined-datasets"]], "Applying the corrected metrology": [[81, "applying-the-corrected-metrology"]], "Array Family": [[20, "array-family"]], "Attendees": [[98, "attendees"]], "Basic parameters": [[34, "basic-parameters"], [36, "basic-parameters"], [37, "basic-parameters"], [38, "basic-parameters"], [39, "basic-parameters"], [40, "basic-parameters"], [41, "basic-parameters"], [42, "basic-parameters"], [43, "basic-parameters"], [44, "basic-parameters"], [45, "basic-parameters"], [46, "basic-parameters"], [47, "basic-parameters"], [49, "basic-parameters"], [50, "basic-parameters"], [51, "basic-parameters"], [52, "basic-parameters"], [53, "basic-parameters"], [54, "basic-parameters"], [55, "basic-parameters"], [57, "basic-parameters"], [58, "basic-parameters"], [59, "basic-parameters"], [60, "basic-parameters"], [61, "basic-parameters"], [62, "basic-parameters"], [63, "basic-parameters"], [64, "basic-parameters"], [65, "basic-parameters"], [66, "basic-parameters"], [67, "basic-parameters"], [68, "basic-parameters"], [69, "basic-parameters"], [70, "basic-parameters"], [72, "basic-parameters"]], "Basis vector search strategies": [[4, "basis-vector-search-strategies"]], "Bookkeeping": [[76, "bookkeeping"]], "Bravais Lattice Refinement": [[82, "bravais-lattice-refinement"], [86, "bravais-lattice-refinement"], [87, "bravais-lattice-refinement"]], "Bravais lattice determination": [[88, "bravais-lattice-determination"]], "Build instructions": [[48, "build-instructions"]], "Built-in help": [[7, "built-in-help"]], "Centred or pseudocentred?": [[77, "centred-or-pseudocentred"]], "Check indexing symmetry": [[78, "check-indexing-symmetry"]], "Checking the symmetry": [[87, "checking-the-symmetry"]], "Class Methods": [[4, "class-methods"]], "Cluster Comparisons": [[76, "cluster-comparisons"]], "Conclusions": [[77, "conclusions"], [78, "conclusions"]], "Contact": [[90, "contact"]], "Contents": [[4, "contents"]], "Conventions": [[2, "conventions"]], "Converting to a centred lattice": [[77, "converting-to-a-centred-lattice"]], "Coordinate frames": [[2, "coordinate-frames"]], "DIALS 1: 12th-13th June 2012 (Diamond Light Source, UK)": [[97, "dials-1-12th-13th-june-2012-diamond-light-source-uk"]], "DIALS Application to XFEL Crystallography": [[95, "dials-application-to-xfel-crystallography"]], "DIALS East": [[0, "dials-east"]], "DIALS How-To guides": [[89, "dials-how-to-guides"]], "DIALS Journal Articles": [[95, "dials-journal-articles"]], "DIALS License": [[92, "dials-license"]], "DIALS Newsletter Articles": [[95, "dials-newsletter-articles"]], "DIALS Reports": [[95, "dials-reports"]], "DIALS Synchrotron Applications": [[95, "dials-synchrotron-applications"]], "DIALS West": [[0, "dials-west"]], "DIALS for neutron diffraction": [[94, "dials-for-neutron-diffraction"]], "DIALS-3: 22nd May 2013 (Cambridge, UK)": [[98, "dials-3-22nd-may-2013-cambridge-uk"]], "DIALS: Diffraction Integration for Advanced Light Sources": [[90, "dials-diffraction-integration-for-advanced-light-sources"]], "DPF3 Part 1: Correcting poor initial geometry": [[78, "dpf3-part-1-correcting-poor-initial-geometry"]], "DPF3 Part 2: A question of centring": [[77, "dpf3-part-2-a-question-of-centring"]], "Data": [[74, "data"], [75, "data"], [76, "data"], [88, "data"]], "Data collection videos": [[73, "data-collection-videos"]], "Data files": [[3, "data-files"]], "Dataset 1": [[75, "dataset-1"], [75, "id1"], [75, "id11"]], "Dataset 2": [[75, "dataset-2"], [75, "id2"], [75, "id12"]], "Dataset 3": [[75, "dataset-3"], [75, "id3"], [75, "id13"]], "Dataset 4": [[75, "dataset-4"], [75, "id4"], [75, "id14"]], "Dataset 5": [[75, "dataset-5"], [75, "id5"], [75, "id15"]], "Dataset 6": [[75, "dataset-6"], [75, "id6"], [75, "id8"], [75, "id10"], [75, "id16"]], "Dataset 7": [[75, "dataset-7"], [75, "id7"], [75, "id17"]], "Datasets 1-5 & 7": [[75, "datasets-1-5-7"], [75, "id9"]], "Defining a scaling model": [[4, "defining-a-scaling-model"]], "Delta CC-half": [[76, "delta-cc-half"]], "Details": [[35, "details"]], "Detector distance": [[74, "detector-distance"]], "Determining lattice symmetry": [[74, "determining-lattice-symmetry"]], "Developer Examples": [[5, "developer-examples"]], "Development Builds": [[91, "development-builds"]], "Development Teams": [[0, "development-teams"]], "Dials parameters": [[48, "dials-parameters"]], "Discover a better experimental model": [[78, "discover-a-better-experimental-model"]], "Distl parameters": [[48, "distl-parameters"]], "Documentation": [[8, "documentation"]], "Downloading the DIALS regression test data": [[9, "downloading-the-dials-regression-test-data"]], "Entry points": [[4, "entry-points"]], "Example": [[40, "example"]], "Example use cases": [[43, "example-use-cases"]], "Examples use cases": [[72, "examples-use-cases"]], "Excluding bad frames": [[73, "excluding-bad-frames"]], "Experiment list files": [[3, "experiment-list-files"]], "Explorations of Reciprocal Space": [[76, "explorations-of-reciprocal-space"]], "Exploratory analysis": [[74, "exploratory-analysis"]], "Export": [[93, "export"]], "Export the data": [[73, "export-the-data"]], "Exporting": [[88, "exporting"]], "Exporting as MTZ": [[87, "exporting-as-mtz"]], "Exporting to unmerged MTZ": [[82, "exporting-to-unmerged-mtz"], [86, "exporting-to-unmerged-mtz"]], "Extending DIALS": [[4, "extending-dials"]], "Extending dials.index": [[4, "extending-dials-index"]], "Extending dials.scale": [[4, "extending-dials-scale"]], "Extending profile models": [[4, "extending-profile-models"]], "Extensions": [[31, "extensions"]], "Feedback": [[79, "feedback"]], "Find Spots": [[78, "find-spots"], [82, "find-spots"], [86, "find-spots"], [87, "find-spots"]], "Find spots": [[73, "find-spots"]], "Find the Bravais lattice (optional)": [[73, "find-the-bravais-lattice-optional"]], "Find the beam centre": [[73, "find-the-beam-centre"]], "Full parameter definitions": [[34, "full-parameter-definitions"], [35, "full-parameter-definitions"], [36, "full-parameter-definitions"], [37, "full-parameter-definitions"], [38, "full-parameter-definitions"], [39, "full-parameter-definitions"], [40, "full-parameter-definitions"], [41, "full-parameter-definitions"], [42, "full-parameter-definitions"], [43, "full-parameter-definitions"], [44, "full-parameter-definitions"], [45, "full-parameter-definitions"], [46, "full-parameter-definitions"], [47, "full-parameter-definitions"], [49, "full-parameter-definitions"], [50, "full-parameter-definitions"], [51, "full-parameter-definitions"], [52, "full-parameter-definitions"], [53, "full-parameter-definitions"], [54, "full-parameter-definitions"], [55, "full-parameter-definitions"], [56, "full-parameter-definitions"], [57, "full-parameter-definitions"], [58, "full-parameter-definitions"], [59, "full-parameter-definitions"], [60, "full-parameter-definitions"], [61, "full-parameter-definitions"], [62, "full-parameter-definitions"], [63, "full-parameter-definitions"], [64, "full-parameter-definitions"], [65, "full-parameter-definitions"], [66, "full-parameter-definitions"], [67, "full-parameter-definitions"], [68, "full-parameter-definitions"], [69, "full-parameter-definitions"], [70, "full-parameter-definitions"], [72, "full-parameter-definitions"]], "Funding": [[90, "funding"]], "Further processing": [[74, "further-processing"]], "Further refinement": [[74, "further-refinement"]], "General": [[79, "general"]], "General Notes": [[73, "general-notes"]], "Generate a mask for the beam center (optional)": [[73, "generate-a-mask-for-the-beam-center-optional"]], "Getting started": [[7, "getting-started"]], "Guide to common scaling options": [[1, "guide-to-common-scaling-options"]], "HTML report": [[82, "html-report"], [86, "html-report"]], "Import": [[75, "import"], [78, "import"], [82, "import"], [86, "import"], [87, "import"], [88, "import"]], "Import and Spotfinding": [[85, "import-and-spotfinding"]], "Import images": [[73, "import-images"]], "Importing": [[93, "importing"]], "Indexing": [[73, "indexing"], [74, "indexing"], [75, "indexing"], [78, "indexing"], [82, "indexing"], [85, "indexing"], [86, "indexing"], [87, "indexing"], [88, "indexing"]], "Indexing SSX data with dials.ssx_index": [[96, "indexing-ssx-data-with-dials-ssx-index"]], "Indexing with the corrected beam centre": [[78, "indexing-with-the-corrected-beam-centre"]], "Individual processing": [[83, "individual-processing"]], "Inspecting the results": [[87, "inspecting-the-results"]], "Installation": [[7, "installation"], [91, "installation"], [91, "id1"]], "Installation for Developers": [[9, "installation-for-developers"]], "Integrating SSX data with dials.ssx_integrate": [[96, "integrating-ssx-data-with-dials-ssx-integrate"]], "Integration": [[73, "integration"], [74, "integration"], [75, "integration"], [82, "integration"], [86, "integration"], [87, "integration"], [88, "integration"]], "Intensity Clustering": [[76, "intensity-clustering"]], "Introduction": [[34, "introduction"], [35, "introduction"], [36, "introduction"], [37, "introduction"], [38, "introduction"], [39, "introduction"], [40, "introduction"], [41, "introduction"], [42, "introduction"], [43, "introduction"], [44, "introduction"], [45, "introduction"], [46, "introduction"], [47, "introduction"], [48, "introduction"], [49, "introduction"], [50, "introduction"], [51, "introduction"], [52, "introduction"], [53, "introduction"], [54, "introduction"], [55, "introduction"], [56, "introduction"], [57, "introduction"], [58, "introduction"], [59, "introduction"], [60, "introduction"], [61, "introduction"], [62, "introduction"], [63, "introduction"], [64, "introduction"], [65, "introduction"], [66, "introduction"], [67, "introduction"], [68, "introduction"], [69, "introduction"], [70, "introduction"], [72, "introduction"], [74, "introduction"], [75, "introduction"], [76, "introduction"], [77, "introduction"], [78, "introduction"], [81, "introduction"], [82, "introduction"], [83, "introduction"], [84, "introduction"], [85, "introduction"], [86, "introduction"], [87, "introduction"], [88, "introduction"]], "Joint refinement": [[83, "joint-refinement"]], "Keeping a Development Environment current": [[9, "keeping-a-development-environment-current"]], "Lattice search strategies": [[4, "lattice-search-strategies"]], "Library Reference": [[32, "library-reference"]], "Lysozyme nanocrystals": [[75, "lysozyme-nanocrystals"]], "Mac and Linux binary installers": [[91, "mac-and-linux-binary-installers"]], "Mac graphical binary installers": [[91, "mac-graphical-binary-installers"]], "Manual reprocessing": [[84, "manual-reprocessing"]], "ModuleNotFoundError: No module named \u2018gltbx_gl_ext\u2019": [[9, "modulenotfounderror-no-module-named-gltbx-gl-ext"]], "Multi-crystal analysis with DIALS and BLEND: individual vs joint refinement": [[83, "multi-crystal-analysis-with-dials-and-blend-individual-vs-joint-refinement"]], "Multi-crystal analysis with DIALS and xia2.multiplex": [[76, "multi-crystal-analysis-with-dials-and-xia2-multiplex"]], "Multi-crystal symmetry analysis and scaling with DIALS": [[84, "multi-crystal-symmetry-analysis-and-scaling-with-dials"]], "Multi-dataset symmetry determination": [[73, "multi-dataset-symmetry-determination"]], "Multi-lattice Tutorial": [[85, "multi-lattice-tutorial"]], "Multi-tile refinement": [[81, "multi-tile-refinement"]], "MyD88TIR small wedges": [[74, "myd88tir-small-wedges"]], "Next steps": [[7, "next-steps"]], "Note about pedestal and offset": [[73, "note-about-pedestal-and-offset"]], "Organising committee": [[97, "organising-committee"]], "Orientation matrix": [[2, "orientation-matrix"]], "Orthogonalisation convention": [[2, "orthogonalisation-convention"]], "Other datasets": [[73, "other-datasets"]], "Output for SADABS (alternate path)": [[88, "output-for-sadabs-alternate-path"]], "Parameters": [[7, "parameters"]], "Post Experiment Processing": [[76, "post-experiment-processing"]], "Practicalities for large datasets": [[1, "practicalities-for-large-datasets"]], "Preferential Orientation": [[76, "preferential-orientation"]], "Preparing for multi-tile refinement": [[81, "preparing-for-multi-tile-refinement"]], "Process": [[76, "process"]], "Processing Sequences with Missing Images": [[93, "processing-sequences-with-missing-images"]], "Processing Small Molecule MicroED/3DED: Biotin": [[73, "processing-small-molecule-microed-3ded-biotin"]], "Processing in Detail": [[86, "processing-in-detail"]], "Processing in Detail with DUI": [[87, "processing-in-detail-with-dui"]], "Program and presentations": [[97, "program-and-presentations"], [98, "program-and-presentations"]], "Program documentation": [[71, "program-documentation"]], "Projects": [[94, "projects"]], "Publications": [[95, "publications"]], "Questioning the lattice symmetry": [[77, "questioning-the-lattice-symmetry"]], "Re-import with the correct beam center": [[73, "re-import-with-the-correct-beam-center"]], "Reading experiment and data": [[6, "reading-experiment-and-data"]], "Refine the geometry": [[73, "refine-the-geometry"]], "Refinement": [[82, "refinement"], [86, "refinement"], [87, "refinement"], [88, "refinement"], [93, "refinement"]], "Refinement and Integration": [[85, "refinement-and-integration"]], "Refining multi-tile detector metrology with DIALS": [[81, "refining-multi-tile-detector-metrology-with-dials"]], "Refining the detector distance": [[74, "refining-the-detector-distance"]], "Reflection files": [[3, "reflection-files"]], "SARS-CoV-2 main protease (Mpro)": [[82, "sars-cov-2-main-protease-mpro"]], "SSX processing guide": [[96, "ssx-processing-guide"]], "Scale the data together": [[73, "scale-the-data-together"]], "Scaling": [[73, "scaling"], [74, "scaling"], [87, "scaling"], [88, "scaling"]], "Scaling against a reference dataset": [[1, "scaling-against-a-reference-dataset"]], "Scaling and Merging": [[82, "scaling-and-merging"], [86, "scaling-and-merging"]], "Scaling and merging": [[75, "scaling-and-merging"]], "Scan-varying refinement": [[75, "scan-varying-refinement"]], "Scripted processing": [[74, "scripted-processing"]], "Sets 0-9": [[76, "sets-0-9"]], "Sets 10-19": [[76, "sets-10-19"]], "Sets 20-29": [[76, "sets-20-29"]], "Setting up a Development Environment on Linux or Mac": [[9, "setting-up-a-development-environment-on-linux-or-mac"]], "Small-molecule data reduction tutorial": [[88, "small-molecule-data-reduction-tutorial"]], "Solve the structure": [[73, "solve-the-structure"]], "Sourcing the DIALS environment": [[7, "sourcing-the-dials-environment"]], "Spot finding": [[88, "spot-finding"]], "Spot-finding": [[74, "spot-finding"], [75, "spot-finding"]], "Stable Release: DIALS 3.20.0": [[91, "stable-release-dials-3-20-0"]], "Static model refinement": [[75, "static-model-refinement"]], "Summary of coordinate frames": [[2, "summary-of-coordinate-frames"]], "Symmetry Determination": [[88, "symmetry-determination"]], "Symmetry analysis": [[82, "symmetry-analysis"], [86, "symmetry-analysis"]], "Symmetry, Scaling and Merging": [[85, "symmetry-scaling-and-merging"]], "Table of Contents": [[20, "table-of-contents"], [31, "table-of-contents"]], "Testing the server": [[48, "testing-the-server"]], "The DXTBX goniometer model": [[2, "the-dxtbx-goniometer-model"]], "The diffractometer equation": [[2, "the-diffractometer-equation"]], "The laboratory frame": [[2, "the-laboratory-frame"]], "Tilt axis orientation": [[74, "tilt-axis-orientation"]], "Tutorial data": [[82, "tutorial-data"], [86, "tutorial-data"], [87, "tutorial-data"]], "Tutorials": [[80, "tutorials"]], "Unit Cell Comparisons": [[76, "unit-cell-comparisons"]], "Unit cell refinement": [[88, "unit-cell-refinement"]], "User guide for scaling data with DIALS": [[1, "user-guide-for-scaling-data-with-dials"]], "Using DIALS at Diamond Light Source": [[79, "using-dials-at-diamond-light-source"]], "Using DIALS with xia2": [[79, "using-dials-with-xia2"]], "Util": [[33, "util"]], "What to do next": [[81, "what-to-do-next"]], "What to do next?": [[83, "what-to-do-next"]], "Workshops": [[99, "workshops"]], "Writing a new format class": [[4, "writing-a-new-format-class"]], "dials.algorithms.background": [[10, "module-dials.algorithms.background"]], "dials.algorithms.indexing": [[11, "module-dials.algorithms.indexing"]], "dials.algorithms.indexing.basis_vector_search": [[11, "module-dials.algorithms.indexing.basis_vector_search"]], "dials.algorithms.indexing.indexer": [[11, "module-dials.algorithms.indexing.indexer"]], "dials.algorithms.indexing.lattice_search": [[11, "module-dials.algorithms.indexing.lattice_search"]], "dials.algorithms.indexing.max_cell": [[11, "module-dials.algorithms.indexing.max_cell"]], "dials.algorithms.indexing.model_evaluation": [[11, "module-dials.algorithms.indexing.model_evaluation"]], "dials.algorithms.indexing.stills_indexer": [[11, "module-dials.algorithms.indexing.stills_indexer"]], "dials.algorithms.integration": [[12, "module-dials.algorithms.integration.integrator"]], "dials.algorithms.profile_model": [[13, "module-dials.algorithms.profile_model"]], "dials.algorithms.refinement": [[14, "module-dials.algorithms.refinement.reflection_manager"]], "dials.algorithms.scaling": [[15, "module-dials.algorithms.scaling"]], "dials.algorithms.spot_finding": [[16, "module-dials.algorithms.spot_finding.finder"]], "dials.algorithms.spot_prediction": [[17, "module-dials.algorithms.spot_prediction.reflection_predictor"]], "dials.algorithms.symmetry": [[18, "module-dials.algorithms.symmetry"]], "dials.algorithms.symmetry.cosym": [[18, "module-dials.algorithms.symmetry.cosym"]], "dials.align_crystal": [[34, "dials-align-crystal"]], "dials.anvil_correction": [[35, "dials-anvil-correction"]], "dials.apply_mask": [[36, "dials-apply-mask"]], "dials.check_indexing_symmetry": [[37, "dials-check-indexing-symmetry"]], "dials.combine_experiments": [[38, "dials-combine-experiments"]], "dials.compare_orientation_matrices": [[39, "dials-compare-orientation-matrices"]], "dials.cosym": [[40, "dials-cosym"]], "dials.create_profile_model": [[41, "dials-create-profile-model"]], "dials.estimate_gain": [[42, "dials-estimate-gain"]], "dials.estimate_resolution": [[43, "dials-estimate-resolution"]], "dials.export": [[44, "dials-export"]], "dials.export_bitmaps": [[45, "dials-export-bitmaps"]], "dials.filter_reflections": [[46, "dials-filter-reflections"]], "dials.find_spots": [[47, "dials-find-spots"]], "dials.find_spots_server/client": [[49, "dials-find-spots-server-client"]], "dials.generate_mask": [[50, "dials-generate-mask"]], "dials.image_viewer": [[51, "dials-image-viewer"]], "dials.import": [[52, "dials-import"]], "dials.index": [[53, "dials-index"]], "dials.integrate": [[54, "dials-integrate"]], "dials.merge_cbf": [[55, "dials-merge-cbf"]], "dials.missing_reflections": [[56, "dials-missing-reflections"]], "dials.plot_scan_varying_model": [[57, "dials-plot-scan-varying-model"]], "dials.predict": [[58, "dials-predict"]], "dials.refine": [[59, "dials-refine"]], "dials.refine_bravais_settings": [[60, "dials-refine-bravais-settings"]], "dials.reindex": [[61, "dials-reindex"]], "dials.report": [[62, "dials-report"]], "dials.scale": [[63, "dials-scale"]], "dials.search_beam_position": [[64, "dials-search-beam-position"]], "dials.show": [[65, "dials-show"]], "dials.slice_sequence": [[66, "dials-slice-sequence"]], "dials.spot_counts_per_image": [[67, "dials-spot-counts-per-image"]], "dials.stereographic_projection": [[68, "dials-stereographic-projection"]], "dials.symmetry": [[69, "dials-symmetry"]], "dials.two_theta_refine": [[70, "dials-two-theta-refine"]], "distl/dials apache server": [[48, "distl-dials-apache-server"]], "dxtbx": [[27, "dxtbx"]], "dxtbx.imageset": [[26, "module-dxtbx.imageset"]], "dxtbx.model.beam": [[21, "module-dxtbx.model.beam"]], "dxtbx.model.crystal": [[22, "dxtbx-model-crystal"]], "dxtbx.model.detector": [[23, "dxtbx-model-detector"]], "dxtbx.model.experiment_list": [[24, "dxtbx-model-experiment-list"]], "dxtbx.model.goniometer": [[25, "module-dxtbx.model.goniometer"]], "dxtbx.model.profile": [[28, "module-dxtbx.model.profile"]], "dxtbx.model.scan": [[29, "module-dxtbx.model.scan"]], "dxtbx.serialize": [[30, "module-dxtbx.serialize.imageset"]], "model.model": [[15, "module-dials.algorithms.scaling.model.model"]], "outlier_rejection": [[15, "module-dials.algorithms.scaling.outlier_rejection"]], "understand Static Method": [[4, "understand-static-method"]], "xia2.multiplex": [[72, "xia2-multiplex"], [84, "xia2-multiplex"]]}, "docnames": ["about", "dials_scale_user_guide", "documentation/conventions", "documentation/data_files", "documentation/developer_examples/extending_dials", "documentation/developer_examples/index", "documentation/developer_examples/read_experiment_and_data", "documentation/getting_started", "documentation/index", "documentation/installation_developer", "documentation/library_reference/algorithms/dials.algorithms.background", "documentation/library_reference/algorithms/dials.algorithms.indexing", "documentation/library_reference/algorithms/dials.algorithms.integration", "documentation/library_reference/algorithms/dials.algorithms.profile_model", "documentation/library_reference/algorithms/dials.algorithms.refinement", "documentation/library_reference/algorithms/dials.algorithms.scaling", "documentation/library_reference/algorithms/dials.algorithms.spot_finding", "documentation/library_reference/algorithms/dials.algorithms.spot_prediction", "documentation/library_reference/algorithms/dials.algorithms.symmetry", "documentation/library_reference/algorithms/index", "documentation/library_reference/array_family/index", "documentation/library_reference/dxtbx/beam", "documentation/library_reference/dxtbx/crystal", "documentation/library_reference/dxtbx/detector", "documentation/library_reference/dxtbx/experiment_list", "documentation/library_reference/dxtbx/goniometer", "documentation/library_reference/dxtbx/imageset", "documentation/library_reference/dxtbx/index", "documentation/library_reference/dxtbx/profile", "documentation/library_reference/dxtbx/scan", "documentation/library_reference/dxtbx/serialize", "documentation/library_reference/extensions/index", "documentation/library_reference/index", "documentation/library_reference/util/index", "documentation/programs/dials_align_crystal", "documentation/programs/dials_anvil_correction", "documentation/programs/dials_apply_mask", "documentation/programs/dials_check_indexing_symmetry", "documentation/programs/dials_combine_experiments", "documentation/programs/dials_compare_orientation_matrices", "documentation/programs/dials_cosym", "documentation/programs/dials_create_profile_model", "documentation/programs/dials_estimate_gain", "documentation/programs/dials_estimate_resolution", "documentation/programs/dials_export", "documentation/programs/dials_export_bitmaps", "documentation/programs/dials_filter_reflections", "documentation/programs/dials_find_spots", "documentation/programs/dials_find_spots_apache_server", "documentation/programs/dials_find_spots_server", "documentation/programs/dials_generate_mask", "documentation/programs/dials_image_viewer", "documentation/programs/dials_import", "documentation/programs/dials_index", "documentation/programs/dials_integrate", "documentation/programs/dials_merge_cbf", "documentation/programs/dials_missing_reflections", "documentation/programs/dials_plot_scan_varying_model", "documentation/programs/dials_predict", "documentation/programs/dials_refine", "documentation/programs/dials_refine_bravais_settings", "documentation/programs/dials_reindex", "documentation/programs/dials_report", "documentation/programs/dials_scale", "documentation/programs/dials_search_beam_position", "documentation/programs/dials_show", "documentation/programs/dials_slice_sequence", "documentation/programs/dials_spot_counts_per_image", "documentation/programs/dials_stereographic_projection", "documentation/programs/dials_symmetry", "documentation/programs/dials_two_theta_refine", "documentation/programs/index", "documentation/programs/xia2_multiplex", "documentation/tutorials/3DED/Biotin", "documentation/tutorials/3DED/MyD88", "documentation/tutorials/3DED/lysozyme_nanocrystals", "documentation/tutorials/br_lyso_multi", "documentation/tutorials/centring_vs_pseudocentring", "documentation/tutorials/correcting_poor_initial_geometry_tutorial", "documentation/tutorials/diamond", "documentation/tutorials/index", "documentation/tutorials/metrology_corrections", "documentation/tutorials/mpro_x0692", "documentation/tutorials/multi_crystal_analysis", "documentation/tutorials/multi_crystal_symmetry_and_scaling", "documentation/tutorials/multi_lattice_tutorial", "documentation/tutorials/processing_in_detail_betalactamase", "documentation/tutorials/processing_in_detail_betalactamase_dui", "documentation/tutorials/small_molecule_tutorial", "howto", "index", "installation", "license", "missing-images", "projects", "publications", "ssx_processing_guide", "workshops/DIALS-1", "workshops/dials3d", "workshops/index"], "envversion": {"sphinx": 61, "sphinx.domains.c": 3, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 9, "sphinx.domains.index": 1, "sphinx.domains.javascript": 3, "sphinx.domains.math": 2, "sphinx.domains.python": 4, "sphinx.domains.rst": 2, "sphinx.domains.std": 2, "sphinx.ext.intersphinx": 1, "sphinx.ext.viewcode": 1}, "filenames": ["about.rst", "dials_scale_user_guide.rst", "documentation/conventions.rst", "documentation/data_files.rst", "documentation/developer_examples/extending_dials.rst", "documentation/developer_examples/index.rst", "documentation/developer_examples/read_experiment_and_data.rst", "documentation/getting_started.rst", "documentation/index.rst", "documentation/installation_developer.rst", "documentation/library_reference/algorithms/dials.algorithms.background.rst", "documentation/library_reference/algorithms/dials.algorithms.indexing.rst", "documentation/library_reference/algorithms/dials.algorithms.integration.rst", "documentation/library_reference/algorithms/dials.algorithms.profile_model.rst", "documentation/library_reference/algorithms/dials.algorithms.refinement.rst", "documentation/library_reference/algorithms/dials.algorithms.scaling.rst", "documentation/library_reference/algorithms/dials.algorithms.spot_finding.rst", "documentation/library_reference/algorithms/dials.algorithms.spot_prediction.rst", "documentation/library_reference/algorithms/dials.algorithms.symmetry.rst", "documentation/library_reference/algorithms/index.rst", "documentation/library_reference/array_family/index.rst", "documentation/library_reference/dxtbx/beam.rst", "documentation/library_reference/dxtbx/crystal.rst", "documentation/library_reference/dxtbx/detector.rst", "documentation/library_reference/dxtbx/experiment_list.rst", "documentation/library_reference/dxtbx/goniometer.rst", "documentation/library_reference/dxtbx/imageset.rst", "documentation/library_reference/dxtbx/index.rst", "documentation/library_reference/dxtbx/profile.rst", "documentation/library_reference/dxtbx/scan.rst", "documentation/library_reference/dxtbx/serialize.rst", "documentation/library_reference/extensions/index.rst", "documentation/library_reference/index.rst", "documentation/library_reference/util/index.rst", "documentation/programs/dials_align_crystal.rst", "documentation/programs/dials_anvil_correction.rst", "documentation/programs/dials_apply_mask.rst", "documentation/programs/dials_check_indexing_symmetry.rst", "documentation/programs/dials_combine_experiments.rst", "documentation/programs/dials_compare_orientation_matrices.rst", "documentation/programs/dials_cosym.rst", "documentation/programs/dials_create_profile_model.rst", "documentation/programs/dials_estimate_gain.rst", "documentation/programs/dials_estimate_resolution.rst", "documentation/programs/dials_export.rst", "documentation/programs/dials_export_bitmaps.rst", "documentation/programs/dials_filter_reflections.rst", "documentation/programs/dials_find_spots.rst", "documentation/programs/dials_find_spots_apache_server.rst", "documentation/programs/dials_find_spots_server.rst", "documentation/programs/dials_generate_mask.rst", "documentation/programs/dials_image_viewer.rst", "documentation/programs/dials_import.rst", "documentation/programs/dials_index.rst", "documentation/programs/dials_integrate.rst", "documentation/programs/dials_merge_cbf.rst", "documentation/programs/dials_missing_reflections.rst", "documentation/programs/dials_plot_scan_varying_model.rst", "documentation/programs/dials_predict.rst", "documentation/programs/dials_refine.rst", "documentation/programs/dials_refine_bravais_settings.rst", "documentation/programs/dials_reindex.rst", "documentation/programs/dials_report.rst", "documentation/programs/dials_scale.rst", "documentation/programs/dials_search_beam_position.rst", "documentation/programs/dials_show.rst", "documentation/programs/dials_slice_sequence.rst", "documentation/programs/dials_spot_counts_per_image.rst", "documentation/programs/dials_stereographic_projection.rst", "documentation/programs/dials_symmetry.rst", "documentation/programs/dials_two_theta_refine.rst", "documentation/programs/index.rst", "documentation/programs/xia2_multiplex.rst", "documentation/tutorials/3DED/Biotin.rst", "documentation/tutorials/3DED/MyD88.rst", "documentation/tutorials/3DED/lysozyme_nanocrystals.rst", "documentation/tutorials/br_lyso_multi.rst", "documentation/tutorials/centring_vs_pseudocentring.rst", "documentation/tutorials/correcting_poor_initial_geometry_tutorial.rst", "documentation/tutorials/diamond.rst", "documentation/tutorials/index.rst", "documentation/tutorials/metrology_corrections.rst", "documentation/tutorials/mpro_x0692.rst", "documentation/tutorials/multi_crystal_analysis.rst", "documentation/tutorials/multi_crystal_symmetry_and_scaling.rst", "documentation/tutorials/multi_lattice_tutorial.rst", "documentation/tutorials/processing_in_detail_betalactamase.rst", "documentation/tutorials/processing_in_detail_betalactamase_dui.rst", "documentation/tutorials/small_molecule_tutorial.rst", "howto.rst", "index.rst", "installation.rst", "license.rst", "missing-images.rst", "projects.rst", "publications.rst", "ssx_processing_guide.rst", "workshops/DIALS-1.rst", "workshops/dials3d.rst", "workshops/index.rst"], "indexentries": {"__init__() (dials.algorithms.background.radialaverage method)": [[10, "dials.algorithms.background.RadialAverage.__init__", false]], "__init__() (dials.algorithms.indexing.assign_indices.assignindicesglobal method)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesGlobal.__init__", false]], "__init__() (dials.algorithms.indexing.assign_indices.assignindiceslocal method)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesLocal.__init__", false]], "__init__() (dials.algorithms.indexing.assign_indices.assignindicesstrategy method)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesStrategy.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.fft1d method)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT1D.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.fft3d method)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT3D.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.optimise.basisvectorminimiser method)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorMinimiser.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.optimise.basisvectortarget method)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorTarget.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.realspacegridsearch method)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.__init__", false]], "__init__() (dials.algorithms.indexing.basis_vector_search.strategy method)": [[11, "dials.algorithms.indexing.basis_vector_search.Strategy.__init__", false]], "__init__() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.__init__", false]], "__init__() (dials.algorithms.indexing.lattice_search.lowresspotmatch method)": [[11, "dials.algorithms.indexing.lattice_search.LowResSpotMatch.__init__", false]], "__init__() (dials.algorithms.indexing.lattice_search.pinkindexer method)": [[11, "dials.algorithms.indexing.lattice_search.PinkIndexer.__init__", false]], "__init__() (dials.algorithms.indexing.lattice_search.strategy method)": [[11, "dials.algorithms.indexing.lattice_search.Strategy.__init__", false]], "__init__() (dials.algorithms.indexing.model_evaluation.modelevaluation method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelEvaluation.__init__", false]], "__init__() (dials.algorithms.indexing.model_evaluation.modelrank method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRank.__init__", false]], "__init__() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.__init__", false]], "__init__() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.__init__", false]], "__init__() (dials.algorithms.indexing.nearest_neighbor.neighboranalysis method)": [[11, "dials.algorithms.indexing.nearest_neighbor.NeighborAnalysis.__init__", false]], "__init__() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.__init__", false]], "__init__() (dials.algorithms.indexing.symmetry.symmetryhandler method)": [[11, "dials.algorithms.indexing.symmetry.SymmetryHandler.__init__", false]], "__init__() (dials.algorithms.integration.integrator.executor method)": [[12, "dials.algorithms.integration.integrator.Executor.__init__", false]], "__init__() (dials.algorithms.integration.integrator.integrator method)": [[12, "dials.algorithms.integration.integrator.Integrator.__init__", false]], "__init__() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.__init__", false]], "__init__() (dials.algorithms.integration.integrator.integratorexecutor method)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor.__init__", false]], "__init__() (dials.algorithms.integration.integrator.joblist method)": [[12, "dials.algorithms.integration.integrator.JobList.__init__", false]], "__init__() (dials.algorithms.integration.integrator.parameters method)": [[12, "dials.algorithms.integration.integrator.Parameters.__init__", false]], "__init__() (dials.algorithms.integration.integrator.parameters.filter method)": [[12, "dials.algorithms.integration.integrator.Parameters.Filter.__init__", false]], "__init__() (dials.algorithms.integration.integrator.parameters.profile method)": [[12, "dials.algorithms.integration.integrator.Parameters.Profile.__init__", false]], "__init__() (dials.algorithms.integration.integrator.parameters.profile.validation method)": [[12, "dials.algorithms.integration.integrator.Parameters.Profile.Validation.__init__", false]], "__init__() (dials.algorithms.integration.integrator.processor2d method)": [[12, "dials.algorithms.integration.integrator.Processor2D.__init__", false]], "__init__() (dials.algorithms.integration.integrator.processor3d method)": [[12, "dials.algorithms.integration.integrator.Processor3D.__init__", false]], "__init__() (dials.algorithms.integration.integrator.processorflat3d method)": [[12, "dials.algorithms.integration.integrator.ProcessorFlat3D.__init__", false]], "__init__() (dials.algorithms.integration.integrator.processorsingle2d method)": [[12, "dials.algorithms.integration.integrator.ProcessorSingle2D.__init__", false]], "__init__() (dials.algorithms.integration.integrator.processorstills method)": [[12, "dials.algorithms.integration.integrator.ProcessorStills.__init__", false]], "__init__() (dials.algorithms.integration.integrator.profilemodellerexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor.__init__", false]], "__init__() (dials.algorithms.integration.integrator.profilevalidatorexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor.__init__", false]], "__init__() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.__init__", false]], "__init__() (dials.algorithms.refinement.engine.adaptlbfgs method)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs.__init__", false]], "__init__() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.__init__", false]], "__init__() (dials.algorithms.refinement.engine.gaussnewtoniterations method)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.__init__", false]], "__init__() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.__init__", false]], "__init__() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.__init__", false]], "__init__() (dials.algorithms.refinement.reflection_manager.blockcalculator method)": [[14, "dials.algorithms.refinement.reflection_manager.BlockCalculator.__init__", false]], "__init__() (dials.algorithms.refinement.reflection_manager.lauereflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.LaueReflectionManager.__init__", false]], "__init__() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.__init__", false]], "__init__() (dials.algorithms.refinement.reflection_manager.tofreflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.TOFReflectionManager.__init__", false]], "__init__() (dials.algorithms.refinement.target.laueleastsquaresresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target.LaueLeastSquaresResidualWithRmsdCutoff.__init__", false]], "__init__() (dials.algorithms.refinement.target.leastsquarespositionalresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoff.__init__", false]], "__init__() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.__init__", false]], "__init__() (dials.algorithms.refinement.target_stills.leastsquaresstillsresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff.__init__", false]], "__init__() (dials.algorithms.refinement.weighting_strategies.constantweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.ConstantWeightingStrategy.__init__", false]], "__init__() (dials.algorithms.refinement.weighting_strategies.lauemixedweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.LaueMixedWeightingStrategy.__init__", false]], "__init__() (dials.algorithms.refinement.weighting_strategies.lauestatisticalweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.LaueStatisticalWeightingStrategy.__init__", false]], "__init__() (dials.algorithms.refinement.weighting_strategies.stillsweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.StillsWeightingStrategy.__init__", false]], "__init__() (dials.algorithms.scaling.model.model.arrayscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.__init__", false]], "__init__() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.__init__", false]], "__init__() (dials.algorithms.scaling.model.model.kbscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.__init__", false]], "__init__() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.__init__", false]], "__init__() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.__init__", false]], "__init__() (dials.algorithms.scaling.outlier_rejection.normdevoutlierrejection method)": [[15, "dials.algorithms.scaling.outlier_rejection.NormDevOutlierRejection.__init__", false]], "__init__() (dials.algorithms.scaling.outlier_rejection.outlierrejectionbase method)": [[15, "dials.algorithms.scaling.outlier_rejection.OutlierRejectionBase.__init__", false]], "__init__() (dials.algorithms.scaling.outlier_rejection.simplenormdevoutlierrejection method)": [[15, "dials.algorithms.scaling.outlier_rejection.SimpleNormDevOutlierRejection.__init__", false]], "__init__() (dials.algorithms.scaling.outlier_rejection.targetedoutlierrejection method)": [[15, "dials.algorithms.scaling.outlier_rejection.TargetedOutlierRejection.__init__", false]], "__init__() (dials.algorithms.spot_finding.factory.backgroundgradientfilter method)": [[16, "dials.algorithms.spot_finding.factory.BackgroundGradientFilter.__init__", false]], "__init__() (dials.algorithms.spot_finding.factory.filterrunner method)": [[16, "dials.algorithms.spot_finding.factory.FilterRunner.__init__", false]], "__init__() (dials.algorithms.spot_finding.factory.peakcentroiddistancefilter method)": [[16, "dials.algorithms.spot_finding.factory.PeakCentroidDistanceFilter.__init__", false]], "__init__() (dials.algorithms.spot_finding.factory.spotdensityfilter method)": [[16, "dials.algorithms.spot_finding.factory.SpotDensityFilter.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.extractpixelsfromimage method)": [[16, "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.extractpixelsfromimage2dnoshoeboxes method)": [[16, "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage2DNoShoeboxes.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.extractspots method)": [[16, "dials.algorithms.spot_finding.finder.ExtractSpots.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.extractspotsparalleltask method)": [[16, "dials.algorithms.spot_finding.finder.ExtractSpotsParallelTask.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.spotfinder method)": [[16, "dials.algorithms.spot_finding.finder.SpotFinder.__init__", false]], "__init__() (dials.algorithms.spot_finding.finder.tofspotfinder method)": [[16, "dials.algorithms.spot_finding.finder.TOFSpotFinder.__init__", false]], "__init__() (dials.algorithms.spot_prediction.reflection_predictor.reflectionpredictor method)": [[17, "dials.algorithms.spot_prediction.reflection_predictor.ReflectionPredictor.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.cosymanalysis method)": [[18, "dials.algorithms.symmetry.cosym.CosymAnalysis.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs method)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.scoresubgroup method)": [[18, "dials.algorithms.symmetry.cosym.ScoreSubGroup.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.scoresymmetryelement method)": [[18, "dials.algorithms.symmetry.cosym.ScoreSymmetryElement.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.symmetryanalysis method)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis.__init__", false]], "__init__() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.__init__", false]], "__init__() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.__init__", false]], "__init__() (dials.algorithms.symmetry.laue_group.lauegroupanalysis method)": [[18, "dials.algorithms.symmetry.laue_group.LaueGroupAnalysis.__init__", false]], "__init__() (dials.algorithms.symmetry.laue_group.scorecorrelationcoefficient method)": [[18, "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient.__init__", false]], "__init__() (dials.algorithms.symmetry.laue_group.scoresubgroup method)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSubGroup.__init__", false]], "__init__() (dials.algorithms.symmetry.laue_group.scoresymmetryelement method)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSymmetryElement.__init__", false]], "__init__() (dials.algorithms.symmetry.symmetry_base method)": [[18, "dials.algorithms.symmetry.symmetry_base.__init__", false]], "__init__() (dials.extensions.dispersion_spotfinder_threshold_ext.dispersionspotfinderthresholdext method)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt.__init__", false]], "__init__() (dials.extensions.null_background_ext.nullbackgroundext method)": [[31, "dials.extensions.null_background_ext.NullBackgroundExt.__init__", false]], "__init__() (dials.extensions.simple_background_ext.simplebackgroundext method)": [[31, "dials.extensions.simple_background_ext.SimpleBackgroundExt.__init__", false]], "__init__() (dials.extensions.simple_centroid_ext.simplecentroidext method)": [[31, "dials.extensions.simple_centroid_ext.SimpleCentroidExt.__init__", false]], "__init__() (dials.util.command_line.progressbar method)": [[33, "dials.util.command_line.ProgressBar.__init__", false]], "__init__() (dials.util.command_line.progressbartimer method)": [[33, "dials.util.command_line.ProgressBarTimer.__init__", false]], "__init__() (dials.util.export_mtz.mtzwriterbase method)": [[33, "dials.util.export_mtz.MTZWriterBase.__init__", false]], "__init__() (dials.util.export_mtz.wavelengthgroup method)": [[33, "dials.util.export_mtz.WavelengthGroup.__init__", false]], "__init__() (dials.util.options.argumentparser method)": [[33, "dials.util.options.ArgumentParser.__init__", false]], "__init__() (dials.util.options.argumentparserbase method)": [[33, "dials.util.options.ArgumentParserBase.__init__", false]], "__init__() (dials.util.options.importer method)": [[33, "dials.util.options.Importer.__init__", false]], "__init__() (dials.util.options.optionparser method)": [[33, "dials.util.options.OptionParser.__init__", false]], "__init__() (dials.util.options.philcommandparser method)": [[33, "dials.util.options.PhilCommandParser.__init__", false]], "__init__() (dxtbx.imageset.externallookup method)": [[26, "dxtbx.imageset.ExternalLookup.__init__", false]], "__init__() (dxtbx.imageset.externallookupitembool method)": [[26, "dxtbx.imageset.ExternalLookupItemBool.__init__", false]], "__init__() (dxtbx.imageset.externallookupitemdouble method)": [[26, "dxtbx.imageset.ExternalLookupItemDouble.__init__", false]], "__init__() (dxtbx.imageset.imagegrid method)": [[26, "dxtbx.imageset.ImageGrid.__init__", false]], "__init__() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.__init__", false]], "__init__() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.__init__", false]], "__init__() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.__init__", false]], "__init__() (dxtbx.imageset.memreader method)": [[26, "dxtbx.imageset.MemReader.__init__", false]], "__init__() (dxtbx.model.crystal method)": [[22, "dxtbx.model.Crystal.__init__", false]], "__init__() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.__init__", false]], "__init__() (dxtbx.model.experiment_list.beamcomparison method)": [[24, "dxtbx.model.experiment_list.BeamComparison.__init__", false]], "__init__() (dxtbx.model.experiment_list.detectorcomparison method)": [[24, "dxtbx.model.experiment_list.DetectorComparison.__init__", false]], "__init__() (dxtbx.model.experiment_list.goniometercomparison method)": [[24, "dxtbx.model.experiment_list.GoniometerComparison.__init__", false]], "__init__() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.__init__", false]], "__init__() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.__init__", false]], "__init__() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.__init__", false]], "__init__() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.__init__", false]], "__init__() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.__init__", false]], "__init__() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.__init__", false]], "__init__() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.__init__", false]], "accumulate() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.accumulate", false]], "accumulate() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.accumulate", false]], "achieved() (dials.algorithms.refinement.target.laueleastsquaresresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target.LaueLeastSquaresResidualWithRmsdCutoff.achieved", false]], "achieved() (dials.algorithms.refinement.target.leastsquarespositionalresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoff.achieved", false]], "achieved() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.achieved", false]], "achieved() (dials.algorithms.refinement.target_stills.leastsquaresstillsresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff.achieved", false]], "adaptlbfgs (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs", false]], "adaptlstbx (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx", false]], "add() (dials.algorithms.background.radialaverage method)": [[10, "dials.algorithms.background.RadialAverage.add", false]], "add() (dials.algorithms.integration.integrator.joblist method)": [[12, "dials.algorithms.integration.integrator.JobList.add", false]], "add() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.add", false]], "add_batch_list() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.add_batch_list", false]], "add_column() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.add_column", false]], "add_constant_to_diagonal() (dials.algorithms.refinement.engine.levenbergmarquardtiterations method)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.add_constant_to_diagonal", false]], "add_crystal() (dials.util.export_mtz.mtzwriterbase method)": [[33, "dials.util.export_mtz.MTZWriterBase.add_crystal", false]], "add_dataset() (dials.util.export_mtz.madmergedmtzwriter method)": [[33, "dials.util.export_mtz.MADMergedMTZWriter.add_dataset", false]], "add_dataset() (dials.util.export_mtz.mergedmtzwriter method)": [[33, "dials.util.export_mtz.MergedMTZWriter.add_dataset", false]], "add_empty_dataset() (dials.util.export_mtz.mtzwriterbase method)": [[33, "dials.util.export_mtz.MTZWriterBase.add_empty_dataset", false]], "add_experiment() (dials.util.export_mtz.wavelengthgroup method)": [[33, "dials.util.export_mtz.WavelengthGroup.add_experiment", false]], "add_group() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.add_group", false]], "add_panel() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.add_panel", false]], "add_row() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.add_row", false]], "algorithm() (dials.extensions.gaussian_rs_profile_model_ext.gaussianrsprofilemodelext static method)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt.algorithm", false]], "all_laue() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.all_laue", false]], "all_rotations() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.all_rotations", false]], "all_sequences() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.all_sequences", false]], "all_stills() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.all_stills", false]], "all_tof() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.all_tof", false]], "append() (dials.algorithms.indexing.model_evaluation.modelrank method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRank.append", false]], "append() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.append", false]], "append() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.append", false]], "apply_hkl_offset() (in module dials.algorithms.indexing.indexer)": [[11, "dials.algorithms.indexing.indexer.apply_hkl_offset", false]], "apply_symmetry() (dials.algorithms.indexing.symmetry.symmetryhandler method)": [[11, "dials.algorithms.indexing.symmetry.SymmetryHandler.apply_symmetry", false]], "argumenthandlingerrorinfo (class in dials.util.options)": [[33, "dials.util.options.ArgumentHandlingErrorInfo", false]], "argumentparser (class in dials.util.options)": [[33, "dials.util.options.ArgumentParser", false]], "argumentparserbase (class in dials.util.options)": [[33, "dials.util.options.ArgumentParserBase", false]], "arrayscalingmodel (class in dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel", false]], "as_dict() (dials.algorithms.symmetry.cosym.cosymanalysis method)": [[18, "dials.algorithms.symmetry.cosym.CosymAnalysis.as_dict", false]], "as_dict() (dials.algorithms.symmetry.cosym.scoresubgroup method)": [[18, "dials.algorithms.symmetry.cosym.ScoreSubGroup.as_dict", false]], "as_dict() (dials.algorithms.symmetry.cosym.scoresymmetryelement method)": [[18, "dials.algorithms.symmetry.cosym.ScoreSymmetryElement.as_dict", false]], "as_dict() (dials.algorithms.symmetry.cosym.symmetryanalysis method)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis.as_dict", false]], "as_dict() (dials.algorithms.symmetry.laue_group.lauegroupanalysis method)": [[18, "dials.algorithms.symmetry.laue_group.LaueGroupAnalysis.as_dict", false]], "as_dict() (dials.algorithms.symmetry.laue_group.scoresubgroup method)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSubGroup.as_dict", false]], "as_dict() (dials.algorithms.symmetry.laue_group.scoresymmetryelement method)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSymmetryElement.as_dict", false]], "as_file() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.as_file", false]], "as_imageset() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.as_imageset", false]], "as_json() (dials.algorithms.symmetry.cosym.cosymanalysis method)": [[18, "dials.algorithms.symmetry.cosym.CosymAnalysis.as_json", false]], "as_json() (dials.algorithms.symmetry.laue_group.lauegroupanalysis method)": [[18, "dials.algorithms.symmetry.laue_group.LaueGroupAnalysis.as_json", false]], "as_json() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.as_json", false]], "as_str() (dxtbx.model.crystal method)": [[22, "dxtbx.model.Crystal.as_str", false]], "as_str() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.as_str", false]], "as_str() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.as_str", false]], "assignindicesglobal (class in dials.algorithms.indexing.assign_indices)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesGlobal", false]], "assignindiceslocal (class in dials.algorithms.indexing.assign_indices)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesLocal", false]], "assignindicesstrategy (class in dials.algorithms.indexing.assign_indices)": [[11, "dials.algorithms.indexing.assign_indices.AssignIndicesStrategy", false]], "backgroundgradientfilter (class in dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.BackgroundGradientFilter", false]], "base_package_options (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.base_package_options", false]], "basic_imageset_from_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.basic_imageset_from_dict", false]], "basic_imageset_to_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.basic_imageset_to_dict", false]], "basisvectorminimiser (class in dials.algorithms.indexing.basis_vector_search.optimise)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorMinimiser", false]], "basisvectortarget (class in dials.algorithms.indexing.basis_vector_search.optimise)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorTarget", false]], "beamcomparison (class in dxtbx.model.experiment_list)": [[24, "dxtbx.model.experiment_list.BeamComparison", false]], "beamfactory (class in dxtbx.model.beam)": [[21, "dxtbx.model.beam.BeamFactory", false]], "beams() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.beams", false]], "best_model() (dials.algorithms.indexing.model_evaluation.modelrank method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRank.best_model", false]], "best_model() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.best_model", false]], "best_model() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.best_model", false]], "blockcalculator (class in dials.algorithms.refinement.reflection_manager)": [[14, "dials.algorithms.refinement.reflection_manager.BlockCalculator", false]], "build_up() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.build_up", false]], "calc_2d_rmsd_and_displacements() (in module dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.calc_2D_rmsd_and_displacements", false]], "calc_acentric_subgroups() (in module dials.algorithms.indexing.symmetry)": [[11, "dials.algorithms.indexing.symmetry.calc_acentric_subgroups", false]], "calc_exp_rmsd_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.calc_exp_rmsd_table", false]], "calc_n_param_from_bins() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.calc_n_param_from_bins", false]], "calculate_esds() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.calculate_esds", false]], "calculate_gradients() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.calculate_gradients", false]], "calculate_new_offset() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.calculate_new_offset", false]], "calculate_weighted_mean() (dials.util.export_mtz.wavelengthgroup method)": [[33, "dials.util.export_mtz.WavelengthGroup.calculate_weighted_mean", false]], "calculate_weights() (dials.algorithms.refinement.weighting_strategies.constantweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.ConstantWeightingStrategy.calculate_weights", false]], "calculate_weights() (dials.algorithms.refinement.weighting_strategies.externaldelpsiweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.ExternalDelPsiWeightingStrategy.calculate_weights", false]], "calculate_weights() (dials.algorithms.refinement.weighting_strategies.lauemixedweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.LaueMixedWeightingStrategy.calculate_weights", false]], "calculate_weights() (dials.algorithms.refinement.weighting_strategies.lauestatisticalweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.LaueStatisticalWeightingStrategy.calculate_weights", false]], "calculate_weights() (dials.algorithms.refinement.weighting_strategies.statisticalweightingstrategy static method)": [[14, "dials.algorithms.refinement.weighting_strategies.StatisticalWeightingStrategy.calculate_weights", false]], "calculate_weights() (dials.algorithms.refinement.weighting_strategies.stillsweightingstrategy method)": [[14, "dials.algorithms.refinement.weighting_strategies.StillsWeightingStrategy.calculate_weights", false]], "callback_after_step() (dials.algorithms.refinement.engine.adaptlbfgs method)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs.callback_after_step", false]], "callback_after_step() (dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs method)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs.callback_after_step", false]], "candidate_orientation_matrices() (in module dials.algorithms.indexing.basis_vector_search.combinations)": [[11, "dials.algorithms.indexing.basis_vector_search.combinations.candidate_orientation_matrices", false]], "change_basis() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.change_basis", false]], "change_of_basis_op_to_best_cell() (in module dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.change_of_basis_op_to_best_cell", false]], "check_flags() (dials.algorithms.spot_finding.factory.filterrunner method)": [[16, "dials.algorithms.spot_finding.factory.FilterRunner.check_flags", false]], "choose_best_orientation_matrix() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.choose_best_orientation_matrix", false]], "clear() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.clear", false]], "clear_cache() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.clear_cache", false]], "coefficient() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.coefficient", false]], "coloured() (in module dials.util.command_line)": [[33, "dials.util.command_line.coloured", false]], "combined_scores() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.combined_scores", false]], "command (class in dials.util.command_line)": [[33, "dials.util.command_line.Command", false]], "complete_set() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.complete_set", false]], "complete_set() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.complete_set", false]], "complex() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.complex", false]], "complex() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.complex", false]], "components (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.components", false]], "compute_background() (dials.extensions.null_background_ext.nullbackgroundext method)": [[31, "dials.extensions.null_background_ext.NullBackgroundExt.compute_background", false]], "compute_background() (dials.extensions.simple_background_ext.simplebackgroundext method)": [[31, "dials.extensions.simple_background_ext.SimpleBackgroundExt.compute_background", false]], "compute_centroid() (dials.extensions.simple_centroid_ext.simplecentroidext method)": [[31, "dials.extensions.simple_centroid_ext.SimpleCentroidExt.compute_centroid", false]], "compute_functional() (dials.algorithms.indexing.basis_vector_search.optimise.basisvectortarget method)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorTarget.compute_functional", false]], "compute_functional() (dials.algorithms.indexing.basis_vector_search.realspacegridsearch static method)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.compute_functional", false]], "compute_functional() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.compute_functional", false]], "compute_functional_and_gradients() (dials.algorithms.indexing.basis_vector_search.optimise.basisvectorminimiser method)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorMinimiser.compute_functional_and_gradients", false]], "compute_functional_and_gradients() (dials.algorithms.indexing.basis_vector_search.optimise.basisvectortarget method)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorTarget.compute_functional_and_gradients", false]], "compute_functional_and_gradients() (dials.algorithms.refinement.engine.adaptlbfgs method)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs.compute_functional_and_gradients", false]], "compute_functional_and_gradients() (dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs method)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs.compute_functional_and_gradients", false]], "compute_functional_gradients_and_curvatures() (dials.algorithms.refinement.engine.adaptlbfgs method)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs.compute_functional_gradients_and_curvatures", false]], "compute_functional_gradients_and_curvatures() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.compute_functional_gradients_and_curvatures", false]], "compute_functional_gradients_and_curvatures() (dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs method)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs.compute_functional_gradients_and_curvatures", false]], "compute_functional_gradients_diag() (dials.algorithms.refinement.engine.lbfgscurvs method)": [[14, "dials.algorithms.refinement.engine.LBFGScurvs.compute_functional_gradients_diag", false]], "compute_functional_gradients_diag() (dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs method)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs.compute_functional_gradients_diag", false]], "compute_gradients() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.compute_gradients", false]], "compute_gradients_fd() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.compute_gradients_fd", false]], "compute_residuals() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.compute_residuals", false]], "compute_residuals_and_gradients() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.compute_residuals_and_gradients", false]], "compute_restraints_functional_gradients_and_curvatures() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.compute_restraints_functional_gradients_and_curvatures", false]], "compute_restraints_residuals_and_gradients() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.compute_restraints_residuals_and_gradients", false]], "compute_threshold() (dials.extensions.dispersion_spotfinder_threshold_ext.dispersionspotfinderthresholdext method)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt.compute_threshold", false]], "config_refinery() (dials.algorithms.refinement.refiner.refinerfactory static method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.config_refinery", false]], "config_restraints() (dials.algorithms.refinement.refiner.refinerfactory static method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.config_restraints", false]], "config_sparse() (dials.algorithms.refinement.refiner.refinerfactory static method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.config_sparse", false]], "config_target() (dials.algorithms.refinement.refiner.refinerfactory static method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.config_target", false]], "configdict (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.configdict", false]], "configure_components() (dials.algorithms.scaling.model.model.arrayscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.configure_components", false]], "configure_components() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.configure_components", false]], "configure_components() (dials.algorithms.scaling.model.model.kbscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.configure_components", false]], "configure_components() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.configure_components", false]], "configure_components() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.configure_components", false]], "configure_filter() (dials.algorithms.spot_finding.factory.spotfinderfactory static method)": [[16, "dials.algorithms.spot_finding.factory.SpotFinderFactory.configure_filter", false]], "configure_modules (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.configure_modules", false]], "configure_threshold() (dials.algorithms.spot_finding.factory.spotfinderfactory static method)": [[16, "dials.algorithms.spot_finding.factory.SpotFinderFactory.configure_threshold", false]], "consecutive_refinement_order (dials.algorithms.scaling.model.model.arrayscalingmodel property)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.consecutive_refinement_order", false]], "consecutive_refinement_order (dials.algorithms.scaling.model.model.dosedecay property)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.consecutive_refinement_order", false]], "consecutive_refinement_order (dials.algorithms.scaling.model.model.kbscalingmodel property)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.consecutive_refinement_order", false]], "consecutive_refinement_order (dials.algorithms.scaling.model.model.physicalscalingmodel property)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.consecutive_refinement_order", false]], "consecutive_refinement_order() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.consecutive_refinement_order", false]], "constantweightingstrategy (class in dials.algorithms.refinement.weighting_strategies)": [[14, "dials.algorithms.refinement.weighting_strategies.ConstantWeightingStrategy", false]], "convergence_as_shift_over_esd (dials.algorithms.refinement.engine.gaussnewtoniterations attribute)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.convergence_as_shift_over_esd", false]], "convert_to_cambridge() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.convert_to_cambridge", false]], "copy() (dxtbx.imageset.memreader method)": [[26, "dxtbx.imageset.MemReader.copy", false]], "correlationcoefficientaccumulator (class in dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator", false]], "cosymanalysis (class in dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.CosymAnalysis", false]], "crystal (class in dxtbx.model)": [[22, "dxtbx.model.Crystal", false]], "crystal (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.crystal", false]], "crystal() (in module dxtbx.serialize.load)": [[30, "dxtbx.serialize.load.crystal", false]], "crystalfactory (class in dxtbx.model.crystal)": [[22, "dxtbx.model.crystal.CrystalFactory", false]], "crystals() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.crystals", false]], "curvatures() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.curvatures", false]], "curvatures_fd() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.curvatures_fd", false]], "damping_value (dials.algorithms.refinement.engine.gaussnewtoniterations attribute)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.damping_value", false]], "data (dxtbx.imageset.externallookupitembool property)": [[26, "dxtbx.imageset.ExternalLookupItemBool.data", false]], "data (dxtbx.imageset.externallookupitemdouble property)": [[26, "dxtbx.imageset.ExternalLookupItemDouble.data", false]], "data() (dials.algorithms.integration.integrator.integratorexecutor method)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor.data", false]], "data() (dials.algorithms.integration.integrator.profilemodellerexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor.data", false]], "data() (dials.algorithms.integration.integrator.profilevalidatorexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor.data", false]], "data() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.data", false]], "data() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.data", false]], "default (dials.extensions.gaussian_rs_profile_model_ext.gaussianrsprofilemodelext attribute)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt.default", false]], "default (dials.extensions.simple_centroid_ext.simplecentroidext attribute)": [[31, "dials.extensions.simple_centroid_ext.SimpleCentroidExt.default", false]], "del_last_row() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.del_last_row", false]], "denominator() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.denominator", false]], "dest_dir_prefix (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.dest_dir_prefix", false]], "detector (class in dxtbx.model)": [[23, "dxtbx.model.Detector", false]], "detectorcomparison (class in dxtbx.model.experiment_list)": [[24, "dxtbx.model.experiment_list.DetectorComparison", false]], "detectorfactory (class in dxtbx.model.detector)": [[23, "dxtbx.model.detector.DetectorFactory", false]], "detectors() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.detectors", false]], "determine_auto_absorption_params() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.determine_auto_absorption_params", false]], "determine_esq_outlier_index_arrays() (in module dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.determine_Esq_outlier_index_arrays", false]], "determine_outlier_index_arrays() (in module dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.determine_outlier_index_arrays", false]], "determine_reindex_operator_against_reference() (in module dials.algorithms.symmetry.reindex_to_reference)": [[18, "dials.algorithms.symmetry.reindex_to_reference.determine_reindex_operator_against_reference", false]], "dials.algorithms.background": [[10, "module-dials.algorithms.background", false]], "dials.algorithms.indexing": [[11, "module-dials.algorithms.indexing", false]], "dials.algorithms.indexing.assign_indices": [[11, "module-dials.algorithms.indexing.assign_indices", false]], "dials.algorithms.indexing.basis_vector_search": [[11, "module-dials.algorithms.indexing.basis_vector_search", false]], "dials.algorithms.indexing.basis_vector_search.combinations": [[11, "module-dials.algorithms.indexing.basis_vector_search.combinations", false]], "dials.algorithms.indexing.basis_vector_search.optimise": [[11, "module-dials.algorithms.indexing.basis_vector_search.optimise", false]], "dials.algorithms.indexing.compare_orientation_matrices": [[11, "module-dials.algorithms.indexing.compare_orientation_matrices", false]], "dials.algorithms.indexing.indexer": [[11, "module-dials.algorithms.indexing.indexer", false]], "dials.algorithms.indexing.lattice_search": [[11, "module-dials.algorithms.indexing.lattice_search", false]], "dials.algorithms.indexing.max_cell": [[11, "module-dials.algorithms.indexing.max_cell", false]], "dials.algorithms.indexing.model_evaluation": [[11, "module-dials.algorithms.indexing.model_evaluation", false]], "dials.algorithms.indexing.nearest_neighbor": [[11, "module-dials.algorithms.indexing.nearest_neighbor", false]], "dials.algorithms.indexing.refinement": [[11, "module-dials.algorithms.indexing.refinement", false]], "dials.algorithms.indexing.stills_indexer": [[11, "module-dials.algorithms.indexing.stills_indexer", false]], "dials.algorithms.indexing.symmetry": [[11, "module-dials.algorithms.indexing.symmetry", false]], "dials.algorithms.integration.integrator": [[12, "module-dials.algorithms.integration.integrator", false]], "dials.algorithms.profile_model": [[13, "module-dials.algorithms.profile_model", false]], "dials.algorithms.refinement.engine": [[14, "module-dials.algorithms.refinement.engine", false]], "dials.algorithms.refinement.refiner": [[14, "module-dials.algorithms.refinement.refiner", false]], "dials.algorithms.refinement.reflection_manager": [[14, "module-dials.algorithms.refinement.reflection_manager", false]], "dials.algorithms.refinement.target": [[14, "module-dials.algorithms.refinement.target", false]], "dials.algorithms.refinement.target_stills": [[14, "module-dials.algorithms.refinement.target_stills", false]], "dials.algorithms.refinement.weighting_strategies": [[14, "module-dials.algorithms.refinement.weighting_strategies", false]], "dials.algorithms.scaling": [[15, "module-dials.algorithms.scaling", false]], "dials.algorithms.scaling.model.model": [[15, "module-dials.algorithms.scaling.model.model", false]], "dials.algorithms.scaling.outlier_rejection": [[15, "module-dials.algorithms.scaling.outlier_rejection", false]], "dials.algorithms.spot_finding.factory": [[16, "module-dials.algorithms.spot_finding.factory", false]], "dials.algorithms.spot_finding.finder": [[16, "module-dials.algorithms.spot_finding.finder", false]], "dials.algorithms.spot_prediction.reflection_predictor": [[17, "module-dials.algorithms.spot_prediction.reflection_predictor", false]], "dials.algorithms.symmetry": [[18, "module-dials.algorithms.symmetry", false]], "dials.algorithms.symmetry.cosym": [[18, "module-dials.algorithms.symmetry.cosym", false]], "dials.algorithms.symmetry.cosym.engine": [[18, "module-dials.algorithms.symmetry.cosym.engine", false]], "dials.algorithms.symmetry.cosym.target": [[18, "module-dials.algorithms.symmetry.cosym.target", false]], "dials.algorithms.symmetry.laue_group": [[18, "module-dials.algorithms.symmetry.laue_group", false]], "dials.algorithms.symmetry.reindex_to_reference": [[18, "module-dials.algorithms.symmetry.reindex_to_reference", false]], "dials.array_family.flex": [[20, "module-dials.array_family.flex", false]], "dials.extensions.dispersion_spotfinder_threshold_ext": [[31, "module-dials.extensions.dispersion_spotfinder_threshold_ext", false]], "dials.extensions.gaussian_rs_profile_model_ext": [[31, "module-dials.extensions.gaussian_rs_profile_model_ext", false]], "dials.extensions.null_background_ext": [[31, "module-dials.extensions.null_background_ext", false]], "dials.extensions.simple_background_ext": [[31, "module-dials.extensions.simple_background_ext", false]], "dials.extensions.simple_centroid_ext": [[31, "module-dials.extensions.simple_centroid_ext", false]], "dials.util.command_line": [[33, "module-dials.util.command_line", false]], "dials.util.export_mtz": [[33, "module-dials.util.export_mtz", false]], "dials.util.export_text": [[33, "module-dials.util.export_text", false]], "dials.util.image": [[33, "module-dials.util.image", false]], "dials.util.installer": [[33, "module-dials.util.installer", false]], "dials.util.ioutil": [[33, "module-dials.util.ioutil", false]], "dials.util.nexus": [[33, "module-dials.util.nexus", false]], "dials.util.options": [[33, "module-dials.util.options", false]], "dialsindexerror": [[11, "dials.algorithms.indexing.DialsIndexError", false]], "dialsindexrefineerror": [[11, "dials.algorithms.indexing.DialsIndexRefineError", false]], "diff_phil (dials.util.options.argumentparser property)": [[33, "dials.util.options.ArgumentParser.diff_phil", false]], "diff_phil (dials.util.options.philcommandparser property)": [[33, "dials.util.options.PhilCommandParser.diff_phil", false]], "difference_rotation_matrix_axis_angle() (in module dials.algorithms.indexing.compare_orientation_matrices)": [[11, "dials.algorithms.indexing.compare_orientation_matrices.difference_rotation_matrix_axis_angle", false]], "dim (dials.algorithms.refinement.target.target property)": [[14, "dials.algorithms.refinement.target.Target.dim", false]], "dim (dials.algorithms.symmetry.cosym.target.target attribute)": [[18, "dials.algorithms.symmetry.cosym.target.Target.dim", false]], "disablempmixin (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.DisableMPmixin", false]], "dispersionspotfinderthresholdext (class in dials.extensions.dispersion_spotfinder_threshold_ext)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt", false]], "dosedecay (class in dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.DoseDecay", false]], "dump() (in module dials.util.nexus)": [[33, "dials.util.nexus.dump", false]], "dx (dxtbx.imageset.externallookup property)": [[26, "dxtbx.imageset.ExternalLookup.dx", false]], "dxtbx.imageset": [[26, "module-dxtbx.imageset", false]], "dxtbx.model.beam": [[21, "module-dxtbx.model.beam", false]], "dxtbx.model.crystal": [[22, "module-dxtbx.model.crystal", false]], "dxtbx.model.detector": [[23, "module-dxtbx.model.detector", false]], "dxtbx.model.experiment_list": [[24, "module-dxtbx.model.experiment_list", false]], "dxtbx.model.goniometer": [[25, "module-dxtbx.model.goniometer", false]], "dxtbx.model.profile": [[28, "module-dxtbx.model.profile", false]], "dxtbx.model.scan": [[29, "module-dxtbx.model.scan", false]], "dxtbx.serialize.imageset": [[30, "module-dxtbx.serialize.imageset", false]], "dxtbx.serialize.load": [[30, "module-dxtbx.serialize.load", false]], "dxtbx.serialize.xds": [[30, "module-dxtbx.serialize.xds", false]], "dy (dxtbx.imageset.externallookup property)": [[26, "dxtbx.imageset.ExternalLookup.dy", false]], "e_refine() (in module dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.e_refine", false]], "empty() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.empty", false]], "end() (dials.util.command_line.command class method)": [[33, "dials.util.command_line.Command.end", false]], "error_model (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.error_model", false]], "estimate_global_threshold() (in module dials.extensions.dispersion_spotfinder_threshold_ext)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.estimate_global_threshold", false]], "evaluate() (dials.algorithms.indexing.model_evaluation.modelevaluation method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelEvaluation.evaluate", false]], "evaluate() (dials.algorithms.indexing.model_evaluation.strategy method)": [[11, "dials.algorithms.indexing.model_evaluation.Strategy.evaluate", false]], "exception (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.exception", false]], "executor (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Executor", false]], "exp_nos (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.exp_nos", false]], "experiment_list() (in module dxtbx.serialize.load)": [[30, "dxtbx.serialize.load.experiment_list", false]], "experiment_list_for_crystal() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.experiment_list_for_crystal", false]], "experiment_type (dials.algorithms.refinement.reflection_manager.lauereflectionmanager attribute)": [[14, "dials.algorithms.refinement.reflection_manager.LaueReflectionManager.experiment_type", false]], "experiment_type (dials.algorithms.refinement.reflection_manager.reflectionmanager attribute)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.experiment_type", false]], "experiment_type (dials.algorithms.refinement.reflection_manager.stillsreflectionmanager attribute)": [[14, "dials.algorithms.refinement.reflection_manager.StillsReflectionManager.experiment_type", false]], "experimentlist (class in dxtbx.model)": [[24, "dxtbx.model.ExperimentList", false]], "experimentlistfactory (class in dxtbx.model.experiment_list)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory", false]], "export_as_json() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.export_as_json", false]], "export_mtz() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.export_mtz", false]], "export_reflections() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.export_reflections", false]], "export_text() (in module dials.util.export_text)": [[33, "dials.util.export_text.export_text", false]], "extend() (dials.algorithms.indexing.model_evaluation.modelrank method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRank.extend", false]], "extend() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.extend", false]], "extend() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.extend", false]], "external_lookup (dxtbx.imageset.imageset property)": [[26, "dxtbx.imageset.ImageSet.external_lookup", false]], "external_lookup (dxtbx.imageset.imagesetdata property)": [[26, "dxtbx.imageset.ImageSetData.external_lookup", false]], "externaldelpsiweightingstrategy (class in dials.algorithms.refinement.weighting_strategies)": [[14, "dials.algorithms.refinement.weighting_strategies.ExternalDelPsiWeightingStrategy", false]], "externallookup (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ExternalLookup", false]], "externallookupitembool (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ExternalLookupItemBool", false]], "externallookupitemdouble (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ExternalLookupItemDouble", false]], "extract_reference_intensities() (in module dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.extract_reference_intensities", false]], "extractpixelsfromimage (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage", false]], "extractpixelsfromimage2dnoshoeboxes (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage2DNoShoeboxes", false]], "extractspots (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.ExtractSpots", false]], "extractspotsparalleltask (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.ExtractSpotsParallelTask", false]], "fft1d (class in dials.algorithms.indexing.basis_vector_search)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT1D", false]], "fft3d (class in dials.algorithms.indexing.basis_vector_search)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT3D", false]], "filename (dxtbx.imageset.externallookupitembool property)": [[26, "dxtbx.imageset.ExternalLookupItemBool.filename", false]], "filename (dxtbx.imageset.externallookupitemdouble property)": [[26, "dxtbx.imageset.ExternalLookupItemDouble.filename", false]], "filename_or_none() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.filename_or_none", false]], "filename_to_absolute() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.filename_to_absolute", false]], "filter_by_likelihood() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.filter_by_likelihood", false]], "filter_by_n_indexed() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.filter_by_n_indexed", false]], "filter_by_volume() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.filter_by_volume", false]], "filter_doubled_cell() (in module dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.filter_doubled_cell", false]], "filter_known_symmetry() (in module dials.algorithms.indexing.basis_vector_search.combinations)": [[11, "dials.algorithms.indexing.basis_vector_search.combinations.filter_known_symmetry", false]], "filter_obs() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.filter_obs", false]], "filter_similar_orientations() (in module dials.algorithms.indexing.basis_vector_search.combinations)": [[11, "dials.algorithms.indexing.basis_vector_search.combinations.filter_similar_orientations", false]], "filterrunner (class in dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.FilterRunner", false]], "final_outlier_arrays (dials.algorithms.scaling.outlier_rejection.outlierrejectionbase attribute)": [[15, "dials.algorithms.scaling.outlier_rejection.OutlierRejectionBase.final_outlier_arrays", false]], "finalise() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.finalise", false]], "finalise() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.finalise", false]], "finalize() (dials.algorithms.integration.integrator.integratorexecutor method)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor.finalize", false]], "finalize() (dials.algorithms.integration.integrator.profilemodellerexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor.finalize", false]], "finalize() (dials.algorithms.integration.integrator.profilevalidatorexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor.finalize", false]], "finalize_reflections() (dials.algorithms.integration.integrator.integrator2d static method)": [[12, "dials.algorithms.integration.integrator.Integrator2D.finalize_reflections", false]], "finalize_reflections() (dials.algorithms.integration.integrator.integrator3d static method)": [[12, "dials.algorithms.integration.integrator.Integrator3D.finalize_reflections", false]], "finalize_reflections() (dials.algorithms.integration.integrator.integratorflat3d static method)": [[12, "dials.algorithms.integration.integrator.IntegratorFlat3D.finalize_reflections", false]], "finalize_reflections() (dials.algorithms.integration.integrator.integratorsingle2d static method)": [[12, "dials.algorithms.integration.integrator.IntegratorSingle2D.finalize_reflections", false]], "finalize_reflections() (dials.algorithms.integration.integrator.integratorstills static method)": [[12, "dials.algorithms.integration.integrator.IntegratorStills.finalize_reflections", false]], "find() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.find", false]], "find_basis_vectors() (dials.algorithms.indexing.basis_vector_search.fft1d method)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT1D.find_basis_vectors", false]], "find_basis_vectors() (dials.algorithms.indexing.basis_vector_search.fft3d method)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT3D.find_basis_vectors", false]], "find_basis_vectors() (dials.algorithms.indexing.basis_vector_search.realspacegridsearch method)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.find_basis_vectors", false]], "find_basis_vectors() (dials.algorithms.indexing.basis_vector_search.strategy method)": [[11, "dials.algorithms.indexing.basis_vector_search.Strategy.find_basis_vectors", false]], "find_crystal_models() (dials.algorithms.indexing.lattice_search.lowresspotmatch method)": [[11, "dials.algorithms.indexing.lattice_search.LowResSpotMatch.find_crystal_models", false]], "find_crystal_models() (dials.algorithms.indexing.lattice_search.pinkindexer method)": [[11, "dials.algorithms.indexing.lattice_search.PinkIndexer.find_crystal_models", false]], "find_crystal_models() (dials.algorithms.indexing.lattice_search.strategy method)": [[11, "dials.algorithms.indexing.lattice_search.Strategy.find_crystal_models", false]], "find_lattices() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.find_lattices", false]], "find_matching_symmetry() (in module dials.algorithms.indexing.symmetry)": [[11, "dials.algorithms.indexing.symmetry.find_matching_symmetry", false]], "find_max_cell() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.find_max_cell", false]], "find_max_cell() (in module dials.algorithms.indexing.max_cell)": [[11, "dials.algorithms.indexing.max_cell.find_max_cell", false]], "find_spots() (dials.algorithms.spot_finding.finder.spotfinder method)": [[16, "dials.algorithms.spot_finding.finder.SpotFinder.find_spots", false]], "finished() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.finished", false]], "finished() (dials.util.command_line.progressbar method)": [[33, "dials.util.command_line.ProgressBar.finished", false]], "fit_profiles() (dials.algorithms.integration.integrator.integrator method)": [[12, "dials.algorithms.integration.integrator.Integrator.fit_profiles", false]], "fix_initial_parameter() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.fix_initial_parameter", false]], "fix_initial_parameter() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.fix_initial_parameter", false]], "fix_initial_parameter() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.fix_initial_parameter", false]], "fixed_components (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.fixed_components", false]], "flatten_experiments() (in module dials.util.options)": [[33, "dials.util.options.flatten_experiments", false]], "flatten_reflections() (in module dials.util.options)": [[33, "dials.util.options.flatten_reflections", false]], "format_epilog() (dials.util.options.argumentparserbase method)": [[33, "dials.util.options.ArgumentParserBase.format_epilog", false]], "format_help() (dials.util.options.argumentparser method)": [[33, "dials.util.options.ArgumentParser.format_help", false]], "fraction_indexed (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.fraction_indexed", false]], "frame_hist() (in module dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.frame_hist", false]], "from_args() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_args", false]], "from_data() (dials.algorithms.scaling.model.model.arrayscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.from_data", false]], "from_data() (dials.algorithms.scaling.model.model.dosedecay class method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.from_data", false]], "from_data() (dials.algorithms.scaling.model.model.kbscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.from_data", false]], "from_data() (dials.algorithms.scaling.model.model.physicalscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.from_data", false]], "from_data() (dials.algorithms.scaling.model.model.scalingmodelbase class method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.from_data", false]], "from_dict() (dials.algorithms.scaling.model.model.arrayscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.from_dict", false]], "from_dict() (dials.algorithms.scaling.model.model.dosedecay class method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.from_dict", false]], "from_dict() (dials.algorithms.scaling.model.model.kbscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.from_dict", false]], "from_dict() (dials.algorithms.scaling.model.model.physicalscalingmodel class method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.from_dict", false]], "from_dict() (dials.algorithms.scaling.model.model.scalingmodelbase class method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.from_dict", false]], "from_dict() (dials.extensions.gaussian_rs_profile_model_ext.gaussianrsprofilemodelext class method)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt.from_dict", false]], "from_dict() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.from_dict", false]], "from_dict() (dxtbx.model.crystal static method)": [[22, "dxtbx.model.Crystal.from_dict", false]], "from_dict() (dxtbx.model.crystal.crystalfactory static method)": [[22, "dxtbx.model.crystal.CrystalFactory.from_dict", false]], "from_dict() (dxtbx.model.detector static method)": [[23, "dxtbx.model.Detector.from_dict", false]], "from_dict() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.from_dict", false]], "from_dict() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_dict", false]], "from_dict() (dxtbx.model.goniometer.goniometer static method)": [[25, "dxtbx.model.goniometer.Goniometer.from_dict", false]], "from_dict() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.from_dict", false]], "from_dict() (dxtbx.model.goniometer.multiaxisgoniometer static method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.from_dict", false]], "from_dict() (dxtbx.model.mosaiccrystalkabsch2010 class method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.from_dict", false]], "from_dict() (dxtbx.model.mosaiccrystalsauter2014 class method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.from_dict", false]], "from_dict() (dxtbx.model.profile.profilemodelfactory static method)": [[28, "dxtbx.model.profile.ProfileModelFactory.from_dict", false]], "from_dict() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.from_dict", false]], "from_file() (dxtbx.model.experimentlist static method)": [[24, "dxtbx.model.ExperimentList.from_file", false]], "from_filenames() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_filenames", false]], "from_imageset() (dxtbx.imageset.imagegrid static method)": [[26, "dxtbx.imageset.ImageGrid.from_imageset", false]], "from_imageset_and_crystal() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_imageset_and_crystal", false]], "from_json() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_json", false]], "from_json_file() (dials.algorithms.refinement.engine.journal class method)": [[14, "dials.algorithms.refinement.engine.Journal.from_json_file", false]], "from_json_file() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_json_file", false]], "from_mosflm_matrix() (dxtbx.model.crystal.crystalfactory static method)": [[22, "dxtbx.model.crystal.CrystalFactory.from_mosflm_matrix", false]], "from_parameters() (dials.algorithms.indexing.indexer.indexer static method)": [[11, "dials.algorithms.indexing.indexer.Indexer.from_parameters", false]], "from_parameters() (dials.algorithms.spot_finding.factory.spotfinderfactory static method)": [[16, "dials.algorithms.spot_finding.factory.SpotFinderFactory.from_parameters", false]], "from_parameters_and_experiments() (dials.algorithms.refinement.target.targetfactory static method)": [[14, "dials.algorithms.refinement.target.TargetFactory.from_parameters_and_experiments", false]], "from_parameters_data_experiments() (dials.algorithms.refinement.refiner.refinerfactory class method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.from_parameters_data_experiments", false]], "from_parameters_reflections_experiments() (dials.algorithms.refinement.reflection_manager.reflectionmanagerfactory static method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManagerFactory.from_parameters_reflections_experiments", false]], "from_phil() (dials.algorithms.integration.integrator.parameters static method)": [[12, "dials.algorithms.integration.integrator.Parameters.from_phil", false]], "from_phil() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.from_phil", false]], "from_phil() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.from_phil", false]], "from_phil() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.from_phil", false]], "from_phil() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.from_phil", false]], "from_pickle_file() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_pickle_file", false]], "from_sequence_and_crystal() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_sequence_and_crystal", false]], "from_serialized_format() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_serialized_format", false]], "from_stills_and_crystal() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_stills_and_crystal", false]], "from_template() (dxtbx.imageset.imagesetfactory static method)": [[26, "dxtbx.imageset.ImageSetFactory.from_template", false]], "from_templates() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_templates", false]], "from_templates() (dxtbx.model.experimentlist static method)": [[24, "dxtbx.model.ExperimentList.from_templates", false]], "from_xds() (dxtbx.model.experiment_list.experimentlistfactory static method)": [[24, "dxtbx.model.experiment_list.ExperimentListFactory.from_xds", false]], "gain (dxtbx.imageset.externallookup property)": [[26, "dxtbx.imageset.ExternalLookup.gain", false]], "gaussianrsprofilemodelext (class in dials.extensions.gaussian_rs_profile_model_ext)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt", false]], "gaussnewtoniterations (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations", false]], "generate_from_phil() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.generate_from_phil", false]], "generate_phil_scope() (in module dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.generate_phil_scope", false]], "generate_phil_scope() (in module dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.generate_phil_scope", false]], "get_a_as_sqr() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.get_A_as_sqr", false]], "get_a_inverse_as_sqr() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.get_A_inverse_as_sqr", false]], "get_accepted_refs_size() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_accepted_refs_size", false]], "get_alpha_angle() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_alpha_angle", false]], "get_angles() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.get_angles", false]], "get_array_range() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_array_range", false]], "get_axes() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.get_axes", false]], "get_beam() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_beam", false]], "get_beam() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_beam", false]], "get_beam() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_beam", false]], "get_beam() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_beam", false]], "get_beam() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.get_beam", false]], "get_centroid_analyser() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_centroid_analyser", false]], "get_corrected_data() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_corrected_data", false]], "get_corrected_data() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_corrected_data", false]], "get_correlation_matrix_for_step() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.get_correlation_matrix_for_step", false]], "get_crystal_symmetry() (dxtbx.model.crystal method)": [[22, "dxtbx.model.Crystal.get_crystal_symmetry", false]], "get_data() (dials.util.image.reader method)": [[33, "dials.util.image.reader.get_data", false]], "get_data() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_data", false]], "get_detector() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_detector", false]], "get_detector() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_detector", false]], "get_detector() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_detector", false]], "get_detector() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_detector", false]], "get_detector() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.get_detector", false]], "get_detectorbase() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_detectorbase", false]], "get_direction() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_direction", false]], "get_domain_size_ang() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.get_domain_size_ang", false]], "get_elapsed_time() (dials.util.command_line.progressbartimer method)": [[33, "dials.util.command_line.ProgressBarTimer.get_elapsed_time", false]], "get_entry() (in module dials.util.nexus)": [[33, "dials.util.nexus.get_entry", false]], "get_experiments() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.get_experiments", false]], "get_fixed_rotation() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_fixed_rotation", false]], "get_format_class() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_format_class", false]], "get_format_class() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_format_class", false]], "get_free_reflections() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.get_free_reflections", false]], "get_free_reflections() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_free_reflections", false]], "get_gain() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_gain", false]], "get_gain() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_gain", false]], "get_goniometer() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_goniometer", false]], "get_goniometer() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_goniometer", false]], "get_goniometer() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_goniometer", false]], "get_goniometer() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_goniometer", false]], "get_goniometer() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.get_goniometer", false]], "get_grid_size() (dxtbx.imageset.imagegrid method)": [[26, "dxtbx.imageset.ImageGrid.get_grid_size", false]], "get_half_mosaicity_deg() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.get_half_mosaicity_deg", false]], "get_image_identifier() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_image_identifier", false]], "get_image_identifier() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_image_identifier", false]], "get_indexed() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_indexed", false]], "get_inverse_ub_matrix_from_xparm() (in module dials.util.ioutil)": [[33, "dials.util.ioutil.get_inverse_ub_matrix_from_xparm", false]], "get_kappa_angle() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_kappa_angle", false]], "get_kappa_axis() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_kappa_axis", false]], "get_mask() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_mask", false]], "get_mask() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_mask", false]], "get_master_path() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_master_path", false]], "get_matches() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.get_matches", false]], "get_matches() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_matches", false]], "get_max_inscribed_resolution() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.get_max_inscribed_resolution", false]], "get_max_resolution() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.get_max_resolution", false]], "get_mosaicity() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.get_mosaicity", false]], "get_names() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.get_names", false]], "get_names() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.get_names", false]], "get_nrows() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.get_nrows", false]], "get_num_matches() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.get_num_matches", false]], "get_num_matches_for_experiment() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.get_num_matches_for_experiment", false]], "get_num_matches_for_panel() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.get_num_matches_for_panel", false]], "get_num_scan_points() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_num_scan_points", false]], "get_num_steps() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.get_num_steps", false]], "get_obs() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_obs", false]], "get_omega_angle() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_omega_angle", false]], "get_omega_axis() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_omega_axis", false]], "get_panel_intersection() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.get_panel_intersection", false]], "get_param_reporter() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.get_param_reporter", false]], "get_parameter_correlation_matrix() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.get_parameter_correlation_matrix", false]], "get_params() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_params", false]], "get_path() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_path", false]], "get_path() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_path", false]], "get_pedestal() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_pedestal", false]], "get_phi_angle() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_phi_angle", false]], "get_phi_axis() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_phi_axis", false]], "get_raw_data() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_raw_data", false]], "get_ray_intersection() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.get_ray_intersection", false]], "get_rotation_axis() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_rotation_axis", false]], "get_rotation_axis_datum() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_rotation_axis_datum", false]], "get_sample_size() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.get_sample_size", false]], "get_scan() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_scan", false]], "get_scan() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_scan", false]], "get_scan() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_scan", false]], "get_scan() (dxtbx.imageset.imagesetlazy method)": [[26, "dxtbx.imageset.ImageSetLazy.get_scan", false]], "get_scan() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.get_scan", false]], "get_scan_axis() (dxtbx.model.goniometer.kappagoniometer method)": [[25, "dxtbx.model.goniometer.KappaGoniometer.get_scan_axis", false]], "get_scan_axis() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.get_scan_axis", false]], "get_setting_rotation() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_setting_rotation", false]], "get_setting_rotation_at_scan_point() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_setting_rotation_at_scan_point", false]], "get_setting_rotation_at_scan_points() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.get_setting_rotation_at_scan_points", false]], "get_shared_components() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.get_shared_components", false]], "get_shared_components() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.get_shared_components", false]], "get_shared_components() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.get_shared_components", false]], "get_space_group_type_from_xparm() (in module dials.util.ioutil)": [[33, "dials.util.ioutil.get_space_group_type_from_xparm", false]], "get_spectrum() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_spectrum", false]], "get_template() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.get_template", false]], "get_template() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_template", false]], "get_template() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.get_template", false]], "get_vendor() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.get_vendor", false]], "get_vendortype() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.get_vendortype", false]], "get_weighting_strategy_override() (dials.algorithms.refinement.reflection_manager.reflectionmanagerfactory static method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManagerFactory.get_weighting_strategy_override", false]], "goniometer (class in dxtbx.model.goniometer)": [[25, "dxtbx.model.goniometer.Goniometer", false]], "goniometercomparison (class in dxtbx.model.experiment_list)": [[24, "dxtbx.model.experiment_list.GoniometerComparison", false]], "goniometerfactory (class in dxtbx.model.goniometer)": [[25, "dxtbx.model.goniometer.GoniometerFactory", false]], "goniometers() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.goniometers", false]], "gradient_threshold (dials.algorithms.refinement.engine.gaussnewtoniterations attribute)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.gradient_threshold", false]], "groups_cache() (in module dials.algorithms.indexing.symmetry)": [[11, "dials.algorithms.indexing.symmetry.groups_cache", false]], "has_dynamic_mask() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.has_dynamic_mask", false]], "has_projection_2d() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.has_projection_2d", false]], "has_single_file_reader() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.has_single_file_reader", false]], "heading() (in module dials.util.command_line)": [[33, "dials.util.command_line.heading", false]], "hierarchy() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.hierarchy", false]], "hist() (in module dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.hist", false]], "history (dials.algorithms.refinement.refiner.refiner property)": [[14, "dials.algorithms.refinement.refiner.Refiner.history", false]], "hkl_offset (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.hkl_offset", false]], "id_ (dials.algorithms.scaling.model.model.arrayscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.id_", false]], "id_ (dials.algorithms.scaling.model.model.dosedecay attribute)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.id_", false]], "id_ (dials.algorithms.scaling.model.model.kbscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.id_", false]], "id_ (dials.algorithms.scaling.model.model.physicalscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.id_", false]], "id_ (dials.algorithms.scaling.model.model.scalingmodelbase attribute)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.id_", false]], "identifiers (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.identifiers", false]], "identifiers() (dxtbx.imageset.memreader method)": [[26, "dxtbx.imageset.MemReader.identifiers", false]], "identifiers() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.identifiers", false]], "identify_outliers() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.identify_outliers", false]], "imagegrid (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageGrid", false]], "imagesequence (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageSequence", false]], "imagesequence_from_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.imagesequence_from_dict", false]], "imagesequence_to_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.imagesequence_to_dict", false]], "imageset (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageSet", false]], "imageset() (in module dxtbx.serialize.load)": [[30, "dxtbx.serialize.load.imageset", false]], "imageset_from_anyset() (dxtbx.imageset.imagesetfactory static method)": [[26, "dxtbx.imageset.ImageSetFactory.imageset_from_anyset", false]], "imageset_from_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.imageset_from_dict", false]], "imageset_to_dict() (in module dxtbx.serialize.imageset)": [[30, "dxtbx.serialize.imageset.imageset_to_dict", false]], "imagesetdata (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageSetData", false]], "imagesetfactory (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageSetFactory", false]], "imagesetlazy (class in dxtbx.imageset)": [[26, "dxtbx.imageset.ImageSetLazy", false]], "imagesets() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.imagesets", false]], "imgcif() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.imgCIF", false]], "imgcif() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.imgCIF", false]], "imgcif() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.imgCIF", false]], "imgcif() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.imgCIF", false]], "imgcif_h() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.imgCIF_H", false]], "imgcif_h() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.imgCIF_H", false]], "imgcif_h() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.imgCIF_H", false]], "imgcif_h() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.imgCIF_H", false]], "importer (class in dials.util.options)": [[33, "dials.util.options.Importer", false]], "include_gui_packages (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.include_gui_packages", false]], "indent (dials.util.command_line.command attribute)": [[33, "dials.util.command_line.Command.indent", false]], "index() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.index", false]], "index() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.index", false]], "index_reflections() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.index_reflections", false]], "indexer (class in dials.algorithms.indexing.indexer)": [[11, "dials.algorithms.indexing.indexer.Indexer", false]], "indices() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.indices", false]], "indices() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.indices", false]], "initialise() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.initialise", false]], "initialise_smooth_input() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.initialise_smooth_input", false]], "initialize() (dials.algorithms.integration.integrator.integratorexecutor method)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor.initialize", false]], "initialize() (dials.algorithms.integration.integrator.profilemodellerexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor.initialize", false]], "initialize() (dials.algorithms.integration.integrator.profilevalidatorexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor.initialize", false]], "initialize_reflections() (dials.algorithms.integration.integrator.integrator2d static method)": [[12, "dials.algorithms.integration.integrator.Integrator2D.initialize_reflections", false]], "initialize_reflections() (dials.algorithms.integration.integrator.integrator3d static method)": [[12, "dials.algorithms.integration.integrator.Integrator3D.initialize_reflections", false]], "initialize_reflections() (dials.algorithms.integration.integrator.integratorflat3d static method)": [[12, "dials.algorithms.integration.integrator.IntegratorFlat3D.initialize_reflections", false]], "initialize_reflections() (dials.algorithms.integration.integrator.integratorsingle2d static method)": [[12, "dials.algorithms.integration.integrator.IntegratorSingle2D.initialize_reflections", false]], "initialize_reflections() (dials.algorithms.integration.integrator.integratorstills static method)": [[12, "dials.algorithms.integration.integrator.IntegratorStills.initialize_reflections", false]], "installer (class in dials.util.installer)": [[33, "dials.util.installer.installer", false]], "installer_dir (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.installer_dir", false]], "integrate() (dials.algorithms.integration.integrator.integrator method)": [[12, "dials.algorithms.integration.integrator.Integrator.integrate", false]], "integrate() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.integrate", false]], "integrator (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Integrator", false]], "integrator2d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Integrator2D", false]], "integrator3d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Integrator3D", false]], "integrator3dthreaded (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded", false]], "integratorexecutor (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor", false]], "integratorflat3d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.IntegratorFlat3D", false]], "integratorsingle2d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.IntegratorSingle2D", false]], "integratorstills (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.IntegratorStills", false]], "inv_d2() (dials.algorithms.background.radialaverage method)": [[10, "dials.algorithms.background.RadialAverage.inv_d2", false]], "invalidphilerror": [[33, "dials.util.options.InvalidPhilError", false]], "is_consistent() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.is_consistent", false]], "is_marked_for_rejection() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.is_marked_for_rejection", false]], "is_marked_for_rejection() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.is_marked_for_rejection", false]], "is_scaled (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.is_scaled", false]], "is_similar_to() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.is_similar_to", false]], "is_similar_to() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.is_similar_to", false]], "is_similar_to() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.is_similar_to", false]], "is_similar_to() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.is_similar_to", false]], "is_single_file_reader() (dxtbx.imageset.memreader static method)": [[26, "dxtbx.imageset.MemReader.is_single_file_reader", false]], "iter_levelorder() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.iter_levelorder", false]], "iter_panels() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.iter_panels", false]], "iter_preorder() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.iter_preorder", false]], "jacobian_condition_number() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.jacobian_condition_number", false]], "job() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.job", false]], "joblist (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.JobList", false]], "journal (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.Journal", false]], "kappa() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.kappa", false]], "kappagoniometer (class in dxtbx.model.goniometer)": [[25, "dxtbx.model.goniometer.KappaGoniometer", false]], "kbscalingmodel (class in dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel", false]], "kernel_normalisation() (dials.algorithms.symmetry.symmetry_base static method)": [[18, "dials.algorithms.symmetry.symmetry_base.kernel_normalisation", false]], "known_axis() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.known_axis", false]], "laue_manager() (dials.algorithms.refinement.reflection_manager.reflectionmanagerfactory static method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManagerFactory.laue_manager", false]], "lauegroupanalysis (class in dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.LaueGroupAnalysis", false]], "laueleastsquaresresidualwithrmsdcutoff (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.LaueLeastSquaresResidualWithRmsdCutoff", false]], "lauemixedweightingstrategy (class in dials.algorithms.refinement.weighting_strategies)": [[14, "dials.algorithms.refinement.weighting_strategies.LaueMixedWeightingStrategy", false]], "lauereflectionmanager (class in dials.algorithms.refinement.reflection_manager)": [[14, "dials.algorithms.refinement.reflection_manager.LaueReflectionManager", false]], "lauestatisticalweightingstrategy (class in dials.algorithms.refinement.weighting_strategies)": [[14, "dials.algorithms.refinement.weighting_strategies.LaueStatisticalWeightingStrategy", false]], "lbfgs_with_curvs (class in dials.algorithms.symmetry.cosym.engine)": [[18, "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs", false]], "lbfgscurvs (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.LBFGScurvs", false]], "leastsquarespositionalresidualwithrmsdcutoff (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoff", false]], "leastsquarespositionalresidualwithrmsdcutoffsparse (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoffSparse", false]], "leastsquaresstillsresidualwithrmsdcutoff (class in dials.algorithms.refinement.target_stills)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff", false]], "leastsquaresstillsresidualwithrmsdcutoffsparse (class in dials.algorithms.refinement.target_stills)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoffSparse", false]], "levenbergmarquardtiterations (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations", false]], "limit_image_range() (dials.algorithms.scaling.model.model.arrayscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.limit_image_range", false]], "limit_image_range() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.limit_image_range", false]], "limit_image_range() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.limit_image_range", false]], "limit_image_range() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.limit_image_range", false]], "load() (in module dials.util.nexus)": [[33, "dials.util.nexus.load", false]], "load_error_model() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.load_error_model", false]], "load_image() (dials.algorithms.spot_finding.factory.spotfinderfactory static method)": [[16, "dials.algorithms.spot_finding.factory.SpotFinderFactory.load_image", false]], "log_summary() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.log_summary", false]], "lowresspotmatch (class in dials.algorithms.indexing.lattice_search)": [[11, "dials.algorithms.indexing.lattice_search.LowResSpotMatch", false]], "madmergedmtzwriter (class in dials.util.export_mtz)": [[33, "dials.util.export_mtz.MADMergedMTZWriter", false]], "make_apps (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.make_apps", false]], "make_beam() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.make_beam", false]], "make_combined_plots() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.make_combined_plots", false]], "make_detector() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.make_detector", false]], "make_goniometer() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.make_goniometer", false]], "make_imageset() (dxtbx.imageset.imagesetfactory static method)": [[26, "dxtbx.imageset.ImageSetFactory.make_imageset", false]], "make_kappa_goniometer() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.make_kappa_goniometer", false]], "make_multi_axis_goniometer() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.make_multi_axis_goniometer", false]], "make_polarized_beam() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.make_polarized_beam", false]], "make_polychromatic_beam() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.make_polychromatic_beam", false]], "make_scan() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.make_scan", false]], "make_scan_from_properties() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.make_scan_from_properties", false]], "make_sequence() (dxtbx.imageset.imagesetfactory static method)": [[26, "dxtbx.imageset.ImageSetFactory.make_sequence", false]], "mark_for_rejection() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.mark_for_rejection", false]], "mark_for_rejection() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.mark_for_rejection", false]], "mask (dxtbx.imageset.externallookup property)": [[26, "dxtbx.imageset.ExternalLookup.mask", false]], "masker() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.masker", false]], "masker() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.masker", false]], "master_path() (dxtbx.imageset.memreader static method)": [[26, "dxtbx.imageset.MemReader.master_path", false]], "match_wavelengths() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.match_wavelengths", false]], "max_length (dials.util.command_line.command attribute)": [[33, "dials.util.command_line.Command.max_length", false]], "max_possible_wl (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.max_possible_wl", false]], "max_shift_over_esd (dials.algorithms.refinement.engine.gaussnewtoniterations attribute)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.max_shift_over_esd", false]], "mean() (dials.algorithms.background.radialaverage method)": [[10, "dials.algorithms.background.RadialAverage.mean", false]], "median_unit_cell() (in module dials.algorithms.symmetry)": [[18, "dials.algorithms.symmetry.median_unit_cell", false]], "memreader (class in dxtbx.imageset)": [[26, "dxtbx.imageset.MemReader", false]], "merge_panel_scope_extracts_by_id() (in module dxtbx.model.detector)": [[23, "dxtbx.model.detector.merge_panel_scope_extracts_by_id", false]], "mergedmtzwriter (class in dials.util.export_mtz)": [[33, "dials.util.export_mtz.MergedMTZWriter", false]], "message (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.message", false]], "metric_supergroup() (in module dials.algorithms.indexing.symmetry)": [[11, "dials.algorithms.indexing.symmetry.metric_supergroup", false]], "min_wl (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.min_wl", false]], "minimize_scipy() (in module dials.algorithms.symmetry.cosym.engine)": [[18, "dials.algorithms.symmetry.cosym.engine.minimize_scipy", false]], "minimize_scitbx_lbfgs() (in module dials.algorithms.symmetry.cosym.engine)": [[18, "dials.algorithms.symmetry.cosym.engine.minimize_scitbx_lbfgs", false]], "ml_aniso_normalisation() (dials.algorithms.symmetry.symmetry_base static method)": [[18, "dials.algorithms.symmetry.symmetry_base.ml_aniso_normalisation", false]], "ml_iso_normalisation() (dials.algorithms.symmetry.symmetry_base static method)": [[18, "dials.algorithms.symmetry.symmetry_base.ml_iso_normalisation", false]], "model_likelihood (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.model_likelihood", false]], "modelevaluation (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.ModelEvaluation", false]], "modelrank (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRank", false]], "modelrankfilter (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter", false]], "modelrankweighted (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted", false]], "module": [[10, "module-dials.algorithms.background", false], [11, "module-dials.algorithms.indexing", false], [11, "module-dials.algorithms.indexing.assign_indices", false], [11, "module-dials.algorithms.indexing.basis_vector_search", false], [11, "module-dials.algorithms.indexing.basis_vector_search.combinations", false], [11, "module-dials.algorithms.indexing.basis_vector_search.optimise", false], [11, "module-dials.algorithms.indexing.compare_orientation_matrices", false], [11, "module-dials.algorithms.indexing.indexer", false], [11, "module-dials.algorithms.indexing.lattice_search", false], [11, "module-dials.algorithms.indexing.max_cell", false], [11, "module-dials.algorithms.indexing.model_evaluation", false], [11, "module-dials.algorithms.indexing.nearest_neighbor", false], [11, "module-dials.algorithms.indexing.refinement", false], [11, "module-dials.algorithms.indexing.stills_indexer", false], [11, "module-dials.algorithms.indexing.symmetry", false], [12, "module-dials.algorithms.integration.integrator", false], [13, "module-dials.algorithms.profile_model", false], [14, "module-dials.algorithms.refinement.engine", false], [14, "module-dials.algorithms.refinement.refiner", false], [14, "module-dials.algorithms.refinement.reflection_manager", false], [14, "module-dials.algorithms.refinement.target", false], [14, "module-dials.algorithms.refinement.target_stills", false], [14, "module-dials.algorithms.refinement.weighting_strategies", false], [15, "module-dials.algorithms.scaling", false], [15, "module-dials.algorithms.scaling.model.model", false], [15, "module-dials.algorithms.scaling.outlier_rejection", false], [16, "module-dials.algorithms.spot_finding.factory", false], [16, "module-dials.algorithms.spot_finding.finder", false], [17, "module-dials.algorithms.spot_prediction.reflection_predictor", false], [18, "module-dials.algorithms.symmetry", false], [18, "module-dials.algorithms.symmetry.cosym", false], [18, "module-dials.algorithms.symmetry.cosym.engine", false], [18, "module-dials.algorithms.symmetry.cosym.target", false], [18, "module-dials.algorithms.symmetry.laue_group", false], [18, "module-dials.algorithms.symmetry.reindex_to_reference", false], [20, "module-dials.array_family.flex", false], [21, "module-dxtbx.model.beam", false], [22, "module-dxtbx.model.crystal", false], [23, "module-dxtbx.model.detector", false], [24, "module-dxtbx.model.experiment_list", false], [25, "module-dxtbx.model.goniometer", false], [26, "module-dxtbx.imageset", false], [28, "module-dxtbx.model.profile", false], [29, "module-dxtbx.model.scan", false], [30, "module-dxtbx.serialize.imageset", false], [30, "module-dxtbx.serialize.load", false], [30, "module-dxtbx.serialize.xds", false], [31, "module-dials.extensions.dispersion_spotfinder_threshold_ext", false], [31, "module-dials.extensions.gaussian_rs_profile_model_ext", false], [31, "module-dials.extensions.null_background_ext", false], [31, "module-dials.extensions.simple_background_ext", false], [31, "module-dials.extensions.simple_centroid_ext", false], [33, "module-dials.util.command_line", false], [33, "module-dials.util.export_mtz", false], [33, "module-dials.util.export_text", false], [33, "module-dials.util.image", false], [33, "module-dials.util.installer", false], [33, "module-dials.util.ioutil", false], [33, "module-dials.util.nexus", false], [33, "module-dials.util.options", false]], "mosaiccrystalkabsch2010 (class in dxtbx.model)": [[22, "dxtbx.model.MosaicCrystalKabsch2010", false]], "mosaiccrystalsauter2014 (class in dxtbx.model)": [[22, "dxtbx.model.MosaicCrystalSauter2014", false]], "mtzwriterbase (class in dials.util.export_mtz)": [[33, "dials.util.export_mtz.MTZWriterBase", false]], "mu (dials.algorithms.refinement.engine.levenbergmarquardtiterations property)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.mu", false]], "multi_axis() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.multi_axis", false]], "multi_axis_goniometer_from_phil() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.multi_axis_goniometer_from_phil", false]], "multiaxisgoniometer (class in dxtbx.model.goniometer)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer", false]], "n() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.n", false]], "n_indexed (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.n_indexed", false]], "n_params (dials.algorithms.scaling.model.model.scalingmodelbase property)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.n_params", false]], "name (dials.extensions.dispersion_spotfinder_threshold_ext.dispersionspotfinderthresholdext attribute)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt.name", false]], "name (dials.extensions.gaussian_rs_profile_model_ext.gaussianrsprofilemodelext attribute)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt.name", false]], "name (dials.extensions.null_background_ext.nullbackgroundext attribute)": [[31, "dials.extensions.null_background_ext.NullBackgroundExt.name", false]], "name (dials.extensions.simple_background_ext.simplebackgroundext attribute)": [[31, "dials.extensions.simple_background_ext.SimpleBackgroundExt.name", false]], "name (dials.extensions.simple_centroid_ext.simplecentroidext attribute)": [[31, "dials.extensions.simple_centroid_ext.SimpleCentroidExt.name", false]], "name (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.name", false]], "neighboranalysis (class in dials.algorithms.indexing.nearest_neighbor)": [[11, "dials.algorithms.indexing.nearest_neighbor.NeighborAnalysis", false]], "new() (dxtbx.imageset.imagesetfactory static method)": [[26, "dxtbx.imageset.ImageSetFactory.new", false]], "nframes_hist() (in module dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.nframes_hist", false]], "normdevoutlierrejection (class in dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.NormDevOutlierRejection", false]], "nullbackgroundext (class in dials.extensions.null_background_ext)": [[31, "dials.extensions.null_background_ext.NullBackgroundExt", false]], "nullify_all_single_file_reader_format_instances() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.nullify_all_single_file_reader_format_instances", false]], "num_reflections() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.num_reflections", false]], "num_scan_points (dxtbx.model.goniometer.goniometer property)": [[25, "dxtbx.model.goniometer.Goniometer.num_scan_points", false]], "numerator() (dials.algorithms.symmetry.laue_group.correlationcoefficientaccumulator method)": [[18, "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator.numerator", false]], "optimise_basis_vectors() (in module dials.algorithms.indexing.basis_vector_search.optimise)": [[11, "dials.algorithms.indexing.basis_vector_search.optimise.optimise_basis_vectors", false]], "optionparser (class in dials.util.options)": [[33, "dials.util.options.OptionParser", false]], "outlierrejectionbase (class in dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.OutlierRejectionBase", false]], "overwrite_from_phil() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.overwrite_from_phil", false]], "p_cc_given_not_s (dials.algorithms.symmetry.laue_group.scorecorrelationcoefficient property)": [[18, "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient.p_cc_given_not_s", false]], "p_cc_given_s (dials.algorithms.symmetry.laue_group.scorecorrelationcoefficient property)": [[18, "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient.p_cc_given_s", false]], "p_s_given_cc (dials.algorithms.symmetry.laue_group.scorecorrelationcoefficient property)": [[18, "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient.p_s_given_cc", false]], "parameter_vector_norm() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.parameter_vector_norm", false]], "parameters (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Parameters", false]], "parameters.filter (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Parameters.Filter", false]], "parameters.profile (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Parameters.Profile", false]], "parameters.profile.validation (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Parameters.Profile.Validation", false]], "params() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.params", false]], "parse_args() (dials.util.options.argumentparser method)": [[33, "dials.util.options.ArgumentParser.parse_args", false]], "parse_args() (dials.util.options.philcommandparser method)": [[33, "dials.util.options.PhilCommandParser.parse_args", false]], "parse_known_args() (dials.util.options.argumentparserbase method)": [[33, "dials.util.options.ArgumentParserBase.parse_known_args", false]], "partial_data() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.partial_data", false]], "partial_set() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.partial_set", false]], "partial_set() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.partial_set", false]], "paths() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.paths", false]], "paths() (dxtbx.imageset.memreader method)": [[26, "dxtbx.imageset.MemReader.paths", false]], "peakcentroiddistancefilter (class in dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.PeakCentroidDistanceFilter", false]], "pedestal (dxtbx.imageset.externallookup property)": [[26, "dxtbx.imageset.ExternalLookup.pedestal", false]], "per_image() (dials.algorithms.refinement.reflection_manager.blockcalculator method)": [[14, "dials.algorithms.refinement.reflection_manager.BlockCalculator.per_image", false]], "per_width() (dials.algorithms.refinement.reflection_manager.blockcalculator method)": [[14, "dials.algorithms.refinement.reflection_manager.BlockCalculator.per_width", false]], "phil (dials.util.options.argumentparser property)": [[33, "dials.util.options.ArgumentParser.phil", false]], "phil (dials.util.options.philcommandparser property)": [[33, "dials.util.options.PhilCommandParser.phil", false]], "phil() (dials.extensions.dispersion_spotfinder_threshold_ext.dispersionspotfinderthresholdext static method)": [[31, "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt.phil", false]], "phil() (dials.extensions.gaussian_rs_profile_model_ext.gaussianrsprofilemodelext static method)": [[31, "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt.phil", false]], "phil() (dials.extensions.simple_background_ext.simplebackgroundext static method)": [[31, "dials.extensions.simple_background_ext.SimpleBackgroundExt.phil", false]], "phil_help (dials.algorithms.indexing.basis_vector_search.fft1d attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT1D.phil_help", false]], "phil_help (dials.algorithms.indexing.basis_vector_search.fft3d attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT3D.phil_help", false]], "phil_help (dials.algorithms.indexing.basis_vector_search.realspacegridsearch attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.phil_help", false]], "phil_help (dials.algorithms.indexing.basis_vector_search.strategy attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.Strategy.phil_help", false]], "phil_help (dials.algorithms.indexing.lattice_search.lowresspotmatch attribute)": [[11, "dials.algorithms.indexing.lattice_search.LowResSpotMatch.phil_help", false]], "phil_help (dials.algorithms.indexing.lattice_search.pinkindexer attribute)": [[11, "dials.algorithms.indexing.lattice_search.PinkIndexer.phil_help", false]], "phil_help (dials.algorithms.indexing.lattice_search.strategy attribute)": [[11, "dials.algorithms.indexing.lattice_search.Strategy.phil_help", false]], "phil_scope (dials.algorithms.indexing.basis_vector_search.fft1d attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT1D.phil_scope", false]], "phil_scope (dials.algorithms.indexing.basis_vector_search.fft3d attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.FFT3D.phil_scope", false]], "phil_scope (dials.algorithms.indexing.basis_vector_search.realspacegridsearch attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.phil_scope", false]], "phil_scope (dials.algorithms.indexing.basis_vector_search.strategy attribute)": [[11, "dials.algorithms.indexing.basis_vector_search.Strategy.phil_scope", false]], "phil_scope (dials.algorithms.indexing.lattice_search.lowresspotmatch attribute)": [[11, "dials.algorithms.indexing.lattice_search.LowResSpotMatch.phil_scope", false]], "phil_scope (dials.algorithms.indexing.lattice_search.pinkindexer attribute)": [[11, "dials.algorithms.indexing.lattice_search.PinkIndexer.phil_scope", false]], "phil_scope (dials.algorithms.indexing.lattice_search.strategy attribute)": [[11, "dials.algorithms.indexing.lattice_search.Strategy.phil_scope", false]], "phil_scope (dials.algorithms.scaling.model.model.arrayscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.phil_scope", false]], "phil_scope (dials.algorithms.scaling.model.model.dosedecay attribute)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.phil_scope", false]], "phil_scope (dials.algorithms.scaling.model.model.kbscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.phil_scope", false]], "phil_scope (dials.algorithms.scaling.model.model.physicalscalingmodel attribute)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.phil_scope", false]], "philcommandparser (class in dials.util.options)": [[33, "dials.util.options.PhilCommandParser", false]], "physicalscalingmodel (class in dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel", false]], "pinkindexer (class in dials.algorithms.indexing.lattice_search)": [[11, "dials.algorithms.indexing.lattice_search.PinkIndexer", false]], "pixel_list_to_reflection_table() (in module dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.pixel_list_to_reflection_table", false]], "pixel_list_to_shoeboxes() (in module dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.pixel_list_to_shoeboxes", false]], "plot_displacements() (in module dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.plot_displacements", false]], "plot_histogram() (dials.algorithms.indexing.nearest_neighbor.neighboranalysis method)": [[11, "dials.algorithms.indexing.nearest_neighbor.NeighborAnalysis.plot_histogram", false]], "plot_model_components() (dials.algorithms.scaling.model.model.arrayscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.plot_model_components", false]], "plot_model_components() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.plot_model_components", false]], "plot_model_components() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.plot_model_components", false]], "plot_model_components() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.plot_model_components", false]], "plot_scaling_models() (in module dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.plot_scaling_models", false]], "predict() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.predict", false]], "predict_for_free_reflections() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.predict_for_free_reflections", false]], "predict_for_indexed() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.predict_for_indexed", false]], "predict_for_reflection_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.predict_for_reflection_table", false]], "predict_for_reflection_table() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.predict_for_reflection_table", false]], "predict_for_reflection_table() (dials.algorithms.refinement.target_stills.leastsquaresstillsresidualwithrmsdcutoff method)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff.predict_for_reflection_table", false]], "predictor() (dials.algorithms.spot_prediction.reflection_predictor.reflectionpredictor method)": [[17, "dials.algorithms.spot_prediction.reflection_predictor.ReflectionPredictor.predictor", false]], "prepare_for_step() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.prepare_for_step", false]], "print_exp_rmsd_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.print_exp_rmsd_table", false]], "print_out_of_sample_rmsd_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.print_out_of_sample_rmsd_table", false]], "print_panel_rmsd_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.print_panel_rmsd_table", false]], "print_stats_on_matches() (dials.algorithms.refinement.reflection_manager.lauereflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.LaueReflectionManager.print_stats_on_matches", false]], "print_stats_on_matches() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.print_stats_on_matches", false]], "print_stats_on_matches() (dials.algorithms.refinement.reflection_manager.stillsreflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.StillsReflectionManager.print_stats_on_matches", false]], "print_step_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.print_step_table", false]], "print_time (dials.util.command_line.command attribute)": [[33, "dials.util.command_line.Command.print_time", false]], "process() (dials.algorithms.integration.integrator.executor method)": [[12, "dials.algorithms.integration.integrator.Executor.process", false]], "process() (dials.algorithms.integration.integrator.integratorexecutor method)": [[12, "dials.algorithms.integration.integrator.IntegratorExecutor.process", false]], "process() (dials.algorithms.integration.integrator.profilemodellerexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor.process", false]], "process() (dials.algorithms.integration.integrator.profilevalidatorexecutor method)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor.process", false]], "processor2d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Processor2D", false]], "processor3d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.Processor3D", false]], "processorclass (dials.algorithms.integration.integrator.integrator2d attribute)": [[12, "dials.algorithms.integration.integrator.Integrator2D.ProcessorClass", false]], "processorclass (dials.algorithms.integration.integrator.integrator3d attribute)": [[12, "dials.algorithms.integration.integrator.Integrator3D.ProcessorClass", false]], "processorclass (dials.algorithms.integration.integrator.integratorflat3d attribute)": [[12, "dials.algorithms.integration.integrator.IntegratorFlat3D.ProcessorClass", false]], "processorclass (dials.algorithms.integration.integrator.integratorsingle2d attribute)": [[12, "dials.algorithms.integration.integrator.IntegratorSingle2D.ProcessorClass", false]], "processorclass (dials.algorithms.integration.integrator.integratorstills attribute)": [[12, "dials.algorithms.integration.integrator.IntegratorStills.ProcessorClass", false]], "processorflat3d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ProcessorFlat3D", false]], "processorsingle2d (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ProcessorSingle2D", false]], "processorstills (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ProcessorStills", false]], "product_name (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.product_name", false]], "product_specific_finalize_install() (dials.util.installer.installer method)": [[33, "dials.util.installer.installer.product_specific_finalize_install", false]], "profilemodelfactory (class in dxtbx.model.profile)": [[28, "dxtbx.model.profile.ProfileModelFactory", false]], "profilemodellerexecutor (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ProfileModellerExecutor", false]], "profiles() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.profiles", false]], "profilevalidatorexecutor (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ProfileValidatorExecutor", false]], "progressbar (class in dials.util.command_line)": [[33, "dials.util.command_line.ProgressBar", false]], "progressbartimer (class in dials.util.command_line)": [[33, "dials.util.command_line.ProgressBarTimer", false]], "radialaverage (class in dials.algorithms.background)": [[10, "dials.algorithms.background.RadialAverage", false]], "read() (dxtbx.imageset.memreader method)": [[26, "dxtbx.imageset.MemReader.read", false]], "read_file() (dials.util.image.reader method)": [[33, "dials.util.image.reader.read_file", false]], "reader (class in dials.util.image)": [[33, "dials.util.image.reader", false]], "reader() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.reader", false]], "reader() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.reader", false]], "realspacegridsearch (class in dials.algorithms.indexing.basis_vector_search)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch", false]], "reason_for_termination (dials.algorithms.refinement.engine.journal attribute)": [[14, "dials.algorithms.refinement.engine.Journal.reason_for_termination", false]], "record_intensity_combination_imid() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.record_intensity_combination_Imid", false]], "refine() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.refine", false]], "refine() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.refine", false]], "refine() (in module dials.algorithms.indexing.refinement)": [[11, "dials.algorithms.indexing.refinement.refine", false]], "refiner (class in dials.algorithms.refinement.refiner)": [[14, "dials.algorithms.refinement.refiner.Refiner", false]], "refinerfactory (class in dials.algorithms.refinement.refiner)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory", false]], "refinery (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.Refinery", false]], "reflectionmanager (class in dials.algorithms.integration.integrator)": [[12, "dials.algorithms.integration.integrator.ReflectionManager", false]], "reflectionmanager (class in dials.algorithms.refinement.reflection_manager)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager", false]], "reflectionmanagerfactory (class in dials.algorithms.refinement.reflection_manager)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManagerFactory", false]], "reflectionpredictor (class in dials.algorithms.spot_prediction.reflection_predictor)": [[17, "dials.algorithms.spot_prediction.reflection_predictor.ReflectionPredictor", false]], "reflections_after_outlier_rejection() (dials.algorithms.refinement.refiner.refinerfactory class method)": [[14, "dials.algorithms.refinement.refiner.RefinerFactory.reflections_after_outlier_rejection", false]], "reflections_and_experiments_from_files() (in module dials.util.options)": [[33, "dials.util.options.reflections_and_experiments_from_files", false]], "reject_outliers() (in module dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.reject_outliers", false]], "remove_on_experiment_identifiers() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.remove_on_experiment_identifiers", false]], "remove_sources_default (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.remove_sources_default", false]], "replace() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.replace", false]], "report() (dials.algorithms.integration.integrator.integrator method)": [[12, "dials.algorithms.integration.integrator.Integrator.report", false]], "report() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.report", false]], "report_progress() (dials.algorithms.refinement.engine.levenbergmarquardtiterations method)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.report_progress", false]], "reset_accepted_reflections() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.reset_accepted_reflections", false]], "reset_scan_points() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.reset_scan_points", false]], "resolution_filter_from_array() (in module dials.algorithms.symmetry)": [[18, "dials.algorithms.symmetry.resolution_filter_from_array", false]], "resolution_filter_from_reflections_experiments() (in module dials.algorithms.symmetry)": [[18, "dials.algorithms.symmetry.resolution_filter_from_reflections_experiments", false]], "restart() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.restart", false]], "result (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.Result", false]], "rmsd_names (dials.algorithms.refinement.target.laueleastsquaresresidualwithrmsdcutoff attribute)": [[14, "dials.algorithms.refinement.target.LaueLeastSquaresResidualWithRmsdCutoff.rmsd_names", false]], "rmsd_names (dials.algorithms.refinement.target.target attribute)": [[14, "dials.algorithms.refinement.target.Target.rmsd_names", false]], "rmsd_names (dials.algorithms.refinement.target.tofleastsquaresresidualwithrmsdcutoff attribute)": [[14, "dials.algorithms.refinement.target.TOFLeastSquaresResidualWithRmsdCutoff.rmsd_names", false]], "rmsd_names (dials.algorithms.refinement.target_stills.leastsquaresstillsresidualwithrmsdcutoff attribute)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff.rmsd_names", false]], "rmsd_units (dials.algorithms.refinement.target.laueleastsquaresresidualwithrmsdcutoff attribute)": [[14, "dials.algorithms.refinement.target.LaueLeastSquaresResidualWithRmsdCutoff.rmsd_units", false]], "rmsd_units (dials.algorithms.refinement.target.target attribute)": [[14, "dials.algorithms.refinement.target.Target.rmsd_units", false]], "rmsd_units (dials.algorithms.refinement.target.tofleastsquaresresidualwithrmsdcutoff attribute)": [[14, "dials.algorithms.refinement.target.TOFLeastSquaresResidualWithRmsdCutoff.rmsd_units", false]], "rmsd_units (dials.algorithms.refinement.target_stills.leastsquaresstillsresidualwithrmsdcutoff attribute)": [[14, "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff.rmsd_units", false]], "rmsds (dials.algorithms.indexing.model_evaluation.result attribute)": [[11, "dials.algorithms.indexing.model_evaluation.Result.rmsds", false]], "rmsds() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.rmsds", false]], "rmsds() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.rmsds", false]], "rmsds_for_experiment() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.rmsds_for_experiment", false]], "rmsds_for_panel() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.rmsds_for_panel", false]], "rmsds_for_reflection_table() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.rmsds_for_reflection_table", false]], "rmsds_for_reflection_table() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.rmsds_for_reflection_table", false]], "rotate_around_origin() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.rotate_around_origin", false]], "rotate_around_origin() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.rotate_around_origin", false]], "rotate_crystal() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.rotate_crystal", false]], "rotation_matrix_differences() (in module dials.algorithms.indexing.compare_orientation_matrices)": [[11, "dials.algorithms.indexing.compare_orientation_matrices.rotation_matrix_differences", false]], "rotation_scan_manager() (dials.algorithms.refinement.reflection_manager.reflectionmanagerfactory static method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManagerFactory.rotation_scan_manager", false]], "run() (dials.algorithms.refinement.engine.gaussnewtoniterations method)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.run", false]], "run() (dials.algorithms.refinement.engine.lbfgscurvs method)": [[14, "dials.algorithms.refinement.engine.LBFGScurvs.run", false]], "run() (dials.algorithms.refinement.engine.levenbergmarquardtiterations method)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.run", false]], "run() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.run", false]], "run() (dials.algorithms.refinement.engine.simplelbfgs method)": [[14, "dials.algorithms.refinement.engine.SimpleLBFGS.run", false]], "run() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.run", false]], "run() (dials.algorithms.scaling.outlier_rejection.outlierrejectionbase method)": [[15, "dials.algorithms.scaling.outlier_rejection.OutlierRejectionBase.run", false]], "run() (dials.algorithms.spot_finding.factory.backgroundgradientfilter method)": [[16, "dials.algorithms.spot_finding.factory.BackgroundGradientFilter.run", false]], "run() (dials.algorithms.spot_finding.factory.peakcentroiddistancefilter method)": [[16, "dials.algorithms.spot_finding.factory.PeakCentroidDistanceFilter.run", false]], "run() (dials.algorithms.spot_finding.factory.spotdensityfilter method)": [[16, "dials.algorithms.spot_finding.factory.SpotDensityFilter.run", false]], "run() (dials.algorithms.symmetry.cosym.cosymanalysis method)": [[18, "dials.algorithms.symmetry.cosym.CosymAnalysis.run", false]], "run_lbfgs() (dials.algorithms.refinement.engine.adaptlbfgs method)": [[14, "dials.algorithms.refinement.engine.AdaptLbfgs.run_lbfgs", false]], "scaling_models() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.scaling_models", false]], "scalingmodelbase (class in dials.algorithms.scaling.model.model)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase", false]], "scanfactory (class in dxtbx.model.scan)": [[29, "dxtbx.model.scan.ScanFactory", false]], "scans() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.scans", false]], "scanvaryingrefiner (class in dials.algorithms.refinement.refiner)": [[14, "dials.algorithms.refinement.refiner.ScanVaryingRefiner", false]], "score_by_fraction_indexed() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.score_by_fraction_indexed", false]], "score_by_rmsd_xy() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.score_by_rmsd_xy", false]], "score_by_volume() (dials.algorithms.indexing.model_evaluation.modelrankweighted method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankWeighted.score_by_volume", false]], "score_vectors() (dials.algorithms.indexing.basis_vector_search.realspacegridsearch method)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.score_vectors", false]], "scorecorrelationcoefficient (class in dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient", false]], "scoresubgroup (class in dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.ScoreSubGroup", false]], "scoresubgroup (class in dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSubGroup", false]], "scoresymmetryelement (class in dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.ScoreSymmetryElement", false]], "scoresymmetryelement (class in dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.ScoreSymmetryElement", false]], "search() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.search", false]], "search_directions (dials.algorithms.indexing.basis_vector_search.realspacegridsearch property)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.search_directions", false]], "search_vectors (dials.algorithms.indexing.basis_vector_search.realspacegridsearch property)": [[11, "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch.search_vectors", false]], "select_on_experiment_identifiers() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.select_on_experiment_identifiers", false]], "selection_used_for_refinement() (dials.algorithms.refinement.refiner.refiner method)": [[14, "dials.algorithms.refinement.refiner.Refiner.selection_used_for_refinement", false]], "sensor() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.sensor", false]], "set_angles() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.set_angles", false]], "set_axes() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.set_axes", false]], "set_beam() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.set_beam", false]], "set_beam() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.set_beam", false]], "set_beam() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_beam", false]], "set_cholesky_factor() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.set_cholesky_factor", false]], "set_detector() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.set_detector", false]], "set_detector() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.set_detector", false]], "set_detector() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_detector", false]], "set_dimensions() (dials.algorithms.symmetry.cosym.target.target method)": [[18, "dials.algorithms.symmetry.cosym.target.Target.set_dimensions", false]], "set_domain_size_ang() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.set_domain_size_ang", false]], "set_error_model() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.set_error_model", false]], "set_fixed_rotation() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.set_fixed_rotation", false]], "set_format_class() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_format_class", false]], "set_goniometer() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.set_goniometer", false]], "set_goniometer() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.set_goniometer", false]], "set_goniometer() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_goniometer", false]], "set_half_mosaicity_deg() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.set_half_mosaicity_deg", false]], "set_last_cell() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.set_last_cell", false]], "set_mosaicity() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.set_mosaicity", false]], "set_nproc() (dials.algorithms.refinement.engine.disablempmixin method)": [[14, "dials.algorithms.refinement.engine.DisableMPmixin.set_nproc", false]], "set_nproc() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.set_nproc", false]], "set_params() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_params", false]], "set_rotation_axis() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.set_rotation_axis", false]], "set_rotation_axis_datum() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.set_rotation_axis_datum", false]], "set_scaling_model_as_scaled() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.set_scaling_model_as_scaled", false]], "set_scaling_model_as_unscaled() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.set_scaling_model_as_unscaled", false]], "set_scan() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.set_scan", false]], "set_scan() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.set_scan", false]], "set_scan() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_scan", false]], "set_setting_rotation() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.set_setting_rotation", false]], "set_setting_rotation_at_scan_points() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.set_setting_rotation_at_scan_points", false]], "set_shoebox_background_value() (in module dials.algorithms.background)": [[10, "dials.algorithms.background.set_shoebox_background_value", false]], "set_template() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_template", false]], "set_valid_image_range() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.set_valid_image_range", false]], "set_vendor() (dxtbx.imageset.imagesetdata method)": [[26, "dxtbx.imageset.ImageSetData.set_vendor", false]], "setup_indexing() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.setup_indexing", false]], "setup_mu() (dials.algorithms.refinement.engine.levenbergmarquardtiterations method)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.setup_mu", false]], "shoebox_memory() (dials.algorithms.integration.integrator.joblist method)": [[12, "dials.algorithms.integration.integrator.JobList.shoebox_memory", false]], "shoeboxes_to_reflection_table() (in module dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.shoeboxes_to_reflection_table", false]], "show() (dxtbx.model.crystal method)": [[22, "dxtbx.model.Crystal.show", false]], "show_experiments() (dials.algorithms.indexing.indexer.indexer method)": [[11, "dials.algorithms.indexing.indexer.Indexer.show_experiments", false]], "simple() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.simple", false]], "simple() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.simple", false]], "simple_directional() (dxtbx.model.beam.beamfactory static method)": [[21, "dxtbx.model.beam.BeamFactory.simple_directional", false]], "simplebackgroundext (class in dials.extensions.simple_background_ext)": [[31, "dials.extensions.simple_background_ext.SimpleBackgroundExt", false]], "simplecentroidext (class in dials.extensions.simple_centroid_ext)": [[31, "dials.extensions.simple_centroid_ext.SimpleCentroidExt", false]], "simplelbfgs (class in dials.algorithms.refinement.engine)": [[14, "dials.algorithms.refinement.engine.SimpleLBFGS", false]], "simplenormdevoutlierrejection (class in dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.SimpleNormDevOutlierRejection", false]], "single_axis() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.single_axis", false]], "single_axis_goniometer_from_phil() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.single_axis_goniometer_from_phil", false]], "single_axis_reverse() (dxtbx.model.goniometer.goniometerfactory static method)": [[25, "dxtbx.model.goniometer.GoniometerFactory.single_axis_reverse", false]], "single_file() (dxtbx.model.scan.scanfactory static method)": [[29, "dxtbx.model.scan.ScanFactory.single_file", false]], "size() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.size", false]], "source_packages (dials.util.installer.installer attribute)": [[33, "dials.util.installer.installer.source_packages", false]], "sparsegradientsmixin (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.SparseGradientsMixin", false]], "split() (dials.algorithms.integration.integrator.joblist method)": [[12, "dials.algorithms.integration.integrator.JobList.split", false]], "split() (dials.algorithms.integration.integrator.reflectionmanager method)": [[12, "dials.algorithms.integration.integrator.ReflectionManager.split", false]], "split_jacobian_into_blocks() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.split_jacobian_into_blocks", false]], "split_matches_into_blocks() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.split_matches_into_blocks", false]], "spotdensityfilter (class in dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.SpotDensityFilter", false]], "spotfinder (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.SpotFinder", false]], "spotfinderfactory (class in dials.algorithms.spot_finding.factory)": [[16, "dials.algorithms.spot_finding.factory.SpotFinderFactory", false]], "stars (dials.algorithms.symmetry.cosym.scoresubgroup property)": [[18, "dials.algorithms.symmetry.cosym.ScoreSubGroup.stars", false]], "stars (dials.algorithms.symmetry.cosym.scoresymmetryelement property)": [[18, "dials.algorithms.symmetry.cosym.ScoreSymmetryElement.stars", false]], "start() (dials.util.command_line.command class method)": [[33, "dials.util.command_line.Command.start", false]], "statisticalweightingstrategy (class in dials.algorithms.refinement.weighting_strategies)": [[14, "dials.algorithms.refinement.weighting_strategies.StatisticalWeightingStrategy", false]], "step_backward() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.step_backward", false]], "step_forward() (dials.algorithms.refinement.engine.adaptlstbx method)": [[14, "dials.algorithms.refinement.engine.AdaptLstbx.step_forward", false]], "step_threshold (dials.algorithms.refinement.engine.gaussnewtoniterations attribute)": [[14, "dials.algorithms.refinement.engine.GaussNewtonIterations.step_threshold", false]], "stills_manager() (dials.algorithms.refinement.reflection_manager.reflectionmanagerfactory static method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManagerFactory.stills_manager", false]], "stillsindexer (class in dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer", false]], "stillsindexerbasisvectorsearch (class in dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexerBasisVectorSearch", false]], "stillsindexerknownorientation (class in dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexerKnownOrientation", false]], "stillsindexerlatticesearch (class in dials.algorithms.indexing.stills_indexer)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexerLatticeSearch", false]], "stillsreflectionmanager (class in dials.algorithms.refinement.reflection_manager)": [[14, "dials.algorithms.refinement.reflection_manager.StillsReflectionManager", false]], "stillsweightingstrategy (class in dials.algorithms.refinement.weighting_strategies)": [[14, "dials.algorithms.refinement.weighting_strategies.StillsWeightingStrategy", false]], "strategy (class in dials.algorithms.indexing.basis_vector_search)": [[11, "dials.algorithms.indexing.basis_vector_search.Strategy", false]], "strategy (class in dials.algorithms.indexing.lattice_search)": [[11, "dials.algorithms.indexing.lattice_search.Strategy", false]], "strategy (class in dials.algorithms.indexing.model_evaluation)": [[11, "dials.algorithms.indexing.model_evaluation.Strategy", false]], "subgroups_table() (dials.algorithms.symmetry.cosym.symmetryanalysis static method)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis.subgroups_table", false]], "summary() (dials.algorithms.integration.integrator.integrator method)": [[12, "dials.algorithms.integration.integrator.Integrator.summary", false]], "summary() (dials.algorithms.integration.integrator.integrator3dthreaded method)": [[12, "dials.algorithms.integration.integrator.Integrator3DThreaded.summary", false]], "summary_table() (dials.algorithms.symmetry.cosym.symmetryanalysis static method)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis.summary_table", false]], "sym_ops_table() (dials.algorithms.symmetry.cosym.symmetryanalysis static method)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis.sym_ops_table", false]], "symmetry_base (class in dials.algorithms.symmetry)": [[18, "dials.algorithms.symmetry.symmetry_base", false]], "symmetryanalysis (class in dials.algorithms.symmetry.cosym)": [[18, "dials.algorithms.symmetry.cosym.SymmetryAnalysis", false]], "symmetryhandler (class in dials.algorithms.indexing.symmetry)": [[11, "dials.algorithms.indexing.symmetry.SymmetryHandler", false]], "system_phil (dials.util.options.argumentparser property)": [[33, "dials.util.options.ArgumentParser.system_phil", false]], "system_phil (dials.util.options.philcommandparser property)": [[33, "dials.util.options.PhilCommandParser.system_phil", false]], "target (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.Target", false]], "target (class in dials.algorithms.symmetry.cosym.target)": [[18, "dials.algorithms.symmetry.cosym.target.Target", false]], "targetedoutlierrejection (class in dials.algorithms.scaling.outlier_rejection)": [[15, "dials.algorithms.scaling.outlier_rejection.TargetedOutlierRejection", false]], "targetfactory (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.TargetFactory", false]], "tau (dials.algorithms.refinement.engine.levenbergmarquardtiterations attribute)": [[14, "dials.algorithms.refinement.engine.LevenbergMarquardtIterations.tau", false]], "test_for_termination() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.test_for_termination", false]], "test_objective_increasing_but_not_nref() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.test_objective_increasing_but_not_nref", false]], "test_rmsd_convergence() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.test_rmsd_convergence", false]], "to_crystal() (in module dxtbx.serialize.xds)": [[30, "dxtbx.serialize.xds.to_crystal", false]], "to_dict() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.to_dict", false]], "to_dict() (dxtbx.model.crystal method)": [[22, "dxtbx.model.Crystal.to_dict", false]], "to_dict() (dxtbx.model.detector method)": [[23, "dxtbx.model.Detector.to_dict", false]], "to_dict() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.to_dict", false]], "to_dict() (dxtbx.model.goniometer.goniometer method)": [[25, "dxtbx.model.goniometer.Goniometer.to_dict", false]], "to_dict() (dxtbx.model.goniometer.multiaxisgoniometer method)": [[25, "dxtbx.model.goniometer.MultiAxisGoniometer.to_dict", false]], "to_dict() (dxtbx.model.mosaiccrystalkabsch2010 method)": [[22, "dxtbx.model.MosaicCrystalKabsch2010.to_dict", false]], "to_dict() (dxtbx.model.mosaiccrystalsauter2014 method)": [[22, "dxtbx.model.MosaicCrystalSauter2014.to_dict", false]], "to_imageset() (in module dxtbx.serialize.xds)": [[30, "dxtbx.serialize.xds.to_imageset", false]], "to_json_file() (dials.algorithms.refinement.engine.journal method)": [[14, "dials.algorithms.refinement.engine.Journal.to_json_file", false]], "to_xds (class in dxtbx.serialize.xds)": [[30, "dxtbx.serialize.xds.to_xds", false]], "tofleastsquaresresidualwithrmsdcutoff (class in dials.algorithms.refinement.target)": [[14, "dials.algorithms.refinement.target.TOFLeastSquaresResidualWithRmsdCutoff", false]], "tofreflectionmanager (class in dials.algorithms.refinement.reflection_manager)": [[14, "dials.algorithms.refinement.reflection_manager.TOFReflectionManager", false]], "tofspotfinder (class in dials.algorithms.spot_finding.finder)": [[16, "dials.algorithms.spot_finding.finder.TOFSpotFinder", false]], "traceback (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.traceback", false]], "trunccauchy_pdf() (in module dials.algorithms.symmetry.laue_group)": [[18, "dials.algorithms.symmetry.laue_group.trunccauchy_pdf", false]], "try_read_experiments() (dials.util.options.importer method)": [[33, "dials.util.options.Importer.try_read_experiments", false]], "try_read_experiments_from_images() (dials.util.options.importer method)": [[33, "dials.util.options.Importer.try_read_experiments_from_images", false]], "try_read_reflections() (dials.util.options.importer method)": [[33, "dials.util.options.Importer.try_read_reflections", false]], "two_theta() (dxtbx.model.detector.detectorfactory static method)": [[23, "dxtbx.model.detector.DetectorFactory.two_theta", false]], "type (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.type", false]], "update() (dials.algorithms.scaling.model.model.arrayscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.ArrayScalingModel.update", false]], "update() (dials.algorithms.scaling.model.model.dosedecay method)": [[15, "dials.algorithms.scaling.model.model.DoseDecay.update", false]], "update() (dials.algorithms.scaling.model.model.kbscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.KBScalingModel.update", false]], "update() (dials.algorithms.scaling.model.model.physicalscalingmodel method)": [[15, "dials.algorithms.scaling.model.model.PhysicalScalingModel.update", false]], "update() (dials.algorithms.scaling.model.model.scalingmodelbase method)": [[15, "dials.algorithms.scaling.model.model.ScalingModelBase.update", false]], "update() (dials.util.command_line.progressbar method)": [[33, "dials.util.command_line.ProgressBar.update", false]], "update() (dials.util.command_line.progressbartimer method)": [[33, "dials.util.command_line.ProgressBarTimer.update", false]], "update_analysis() (dials.algorithms.indexing.model_evaluation.modelrankfilter method)": [[11, "dials.algorithms.indexing.model_evaluation.ModelRankFilter.update_analysis", false]], "update_detector_px_mm_data() (dxtbx.imageset.imagesequence method)": [[26, "dxtbx.imageset.ImageSequence.update_detector_px_mm_data", false]], "update_detector_px_mm_data() (dxtbx.imageset.imageset method)": [[26, "dxtbx.imageset.ImageSet.update_detector_px_mm_data", false]], "update_journal() (dials.algorithms.refinement.engine.refinery method)": [[14, "dials.algorithms.refinement.engine.Refinery.update_journal", false]], "update_matches() (dials.algorithms.refinement.target.target method)": [[14, "dials.algorithms.refinement.target.Target.update_matches", false]], "update_residuals() (dials.algorithms.refinement.reflection_manager.lauereflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.LaueReflectionManager.update_residuals", false]], "update_residuals() (dials.algorithms.refinement.reflection_manager.reflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.ReflectionManager.update_residuals", false]], "update_residuals() (dials.algorithms.refinement.reflection_manager.tofreflectionmanager method)": [[14, "dials.algorithms.refinement.reflection_manager.TOFReflectionManager.update_residuals", false]], "validation (dials.util.options.argumenthandlingerrorinfo attribute)": [[33, "dials.util.options.ArgumentHandlingErrorInfo.validation", false]], "warn_if_setting_unused_refinement_protocol_params() (dials.algorithms.indexing.stills_indexer.stillsindexer method)": [[11, "dials.algorithms.indexing.stills_indexer.StillsIndexer.warn_if_setting_unused_refinement_protocol_params", false]], "wavelengthgroup (class in dials.util.export_mtz)": [[33, "dials.util.export_mtz.WavelengthGroup", false]], "wavelengths (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.wavelengths", false]], "weight() (dials.algorithms.background.radialaverage method)": [[10, "dials.algorithms.background.RadialAverage.weight", false]], "weighted_mean (dials.util.export_mtz.wavelengthgroup attribute)": [[33, "dials.util.export_mtz.WavelengthGroup.weighted_mean", false]], "where() (dxtbx.model.experimentlist method)": [[24, "dxtbx.model.ExperimentList.where", false]], "write_columns() (in module dials.util.export_mtz)": [[33, "dials.util.export_mtz.write_columns", false]], "xds_detector_name() (in module dxtbx.serialize.xds)": [[30, "dxtbx.serialize.xds.xds_detector_name", false]], "xds_inp() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.XDS_INP", false]], "xparm_xds() (dxtbx.serialize.xds.to_xds method)": [[30, "dxtbx.serialize.xds.to_xds.xparm_xds", false]]}, "objects": {"dials.algorithms": [[10, 0, 0, "-", "background"], [11, 0, 0, "-", "indexing"], [13, 0, 0, "-", "profile_model"], [15, 0, 0, "-", "scaling"], [18, 0, 0, "-", "symmetry"]], "dials.algorithms.background": [[10, 1, 1, "", "RadialAverage"], [10, 3, 1, "", "set_shoebox_background_value"]], "dials.algorithms.background.RadialAverage": [[10, 2, 1, "", "__init__"], [10, 2, 1, "", "add"], [10, 2, 1, "", "inv_d2"], [10, 2, 1, "", "mean"], [10, 2, 1, "", "weight"]], "dials.algorithms.indexing": [[11, 4, 1, "", "DialsIndexError"], [11, 4, 1, "", "DialsIndexRefineError"], [11, 0, 0, "-", "assign_indices"], [11, 0, 0, "-", "basis_vector_search"], [11, 0, 0, "-", "compare_orientation_matrices"], [11, 0, 0, "-", "indexer"], [11, 0, 0, "-", "lattice_search"], [11, 0, 0, "-", "max_cell"], [11, 0, 0, "-", "model_evaluation"], [11, 0, 0, "-", "nearest_neighbor"], [11, 0, 0, "-", "refinement"], [11, 0, 0, "-", "stills_indexer"], [11, 0, 0, "-", "symmetry"]], "dials.algorithms.indexing.assign_indices": [[11, 1, 1, "", "AssignIndicesGlobal"], [11, 1, 1, "", "AssignIndicesLocal"], [11, 1, 1, "", "AssignIndicesStrategy"]], "dials.algorithms.indexing.assign_indices.AssignIndicesGlobal": [[11, 2, 1, "", "__init__"]], "dials.algorithms.indexing.assign_indices.AssignIndicesLocal": [[11, 2, 1, "", "__init__"]], "dials.algorithms.indexing.assign_indices.AssignIndicesStrategy": [[11, 2, 1, "", "__init__"]], "dials.algorithms.indexing.basis_vector_search": [[11, 1, 1, "", "FFT1D"], [11, 1, 1, "", "FFT3D"], [11, 1, 1, "", "RealSpaceGridSearch"], [11, 1, 1, "", "Strategy"], [11, 0, 0, "-", "combinations"], [11, 0, 0, "-", "optimise"]], "dials.algorithms.indexing.basis_vector_search.FFT1D": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_basis_vectors"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.basis_vector_search.FFT3D": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_basis_vectors"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.basis_vector_search.RealSpaceGridSearch": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "compute_functional"], [11, 2, 1, "", "find_basis_vectors"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"], [11, 2, 1, "", "score_vectors"], [11, 6, 1, "", "search_directions"], [11, 6, 1, "", "search_vectors"]], "dials.algorithms.indexing.basis_vector_search.Strategy": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_basis_vectors"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.basis_vector_search.combinations": [[11, 3, 1, "", "candidate_orientation_matrices"], [11, 3, 1, "", "filter_known_symmetry"], [11, 3, 1, "", "filter_similar_orientations"]], "dials.algorithms.indexing.basis_vector_search.optimise": [[11, 1, 1, "", "BasisVectorMinimiser"], [11, 1, 1, "", "BasisVectorTarget"], [11, 3, 1, "", "optimise_basis_vectors"]], "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorMinimiser": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "compute_functional_and_gradients"]], "dials.algorithms.indexing.basis_vector_search.optimise.BasisVectorTarget": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "compute_functional"], [11, 2, 1, "", "compute_functional_and_gradients"]], "dials.algorithms.indexing.compare_orientation_matrices": [[11, 3, 1, "", "difference_rotation_matrix_axis_angle"], [11, 3, 1, "", "rotation_matrix_differences"]], "dials.algorithms.indexing.indexer": [[11, 1, 1, "", "Indexer"], [11, 3, 1, "", "apply_hkl_offset"]], "dials.algorithms.indexing.indexer.Indexer": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "export_as_json"], [11, 2, 1, "", "export_reflections"], [11, 2, 1, "", "find_lattices"], [11, 2, 1, "", "find_max_cell"], [11, 2, 1, "", "from_parameters"], [11, 2, 1, "", "index"], [11, 2, 1, "", "index_reflections"], [11, 2, 1, "", "refine"], [11, 2, 1, "", "setup_indexing"], [11, 2, 1, "", "show_experiments"]], "dials.algorithms.indexing.lattice_search": [[11, 1, 1, "", "LowResSpotMatch"], [11, 1, 1, "", "PinkIndexer"], [11, 1, 1, "", "Strategy"]], "dials.algorithms.indexing.lattice_search.LowResSpotMatch": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_crystal_models"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.lattice_search.PinkIndexer": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_crystal_models"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.lattice_search.Strategy": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "find_crystal_models"], [11, 5, 1, "", "phil_help"], [11, 5, 1, "", "phil_scope"]], "dials.algorithms.indexing.max_cell": [[11, 3, 1, "", "find_max_cell"]], "dials.algorithms.indexing.model_evaluation": [[11, 1, 1, "", "ModelEvaluation"], [11, 1, 1, "", "ModelRank"], [11, 1, 1, "", "ModelRankFilter"], [11, 1, 1, "", "ModelRankWeighted"], [11, 1, 1, "", "Result"], [11, 1, 1, "", "Strategy"], [11, 3, 1, "", "filter_doubled_cell"]], "dials.algorithms.indexing.model_evaluation.ModelEvaluation": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "evaluate"]], "dials.algorithms.indexing.model_evaluation.ModelRank": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "append"], [11, 2, 1, "", "best_model"], [11, 2, 1, "", "extend"]], "dials.algorithms.indexing.model_evaluation.ModelRankFilter": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "append"], [11, 2, 1, "", "best_model"], [11, 2, 1, "", "extend"], [11, 2, 1, "", "filter_by_likelihood"], [11, 2, 1, "", "filter_by_n_indexed"], [11, 2, 1, "", "filter_by_volume"], [11, 2, 1, "", "update_analysis"]], "dials.algorithms.indexing.model_evaluation.ModelRankWeighted": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "best_model"], [11, 2, 1, "", "combined_scores"], [11, 2, 1, "", "score_by_fraction_indexed"], [11, 2, 1, "", "score_by_rmsd_xy"], [11, 2, 1, "", "score_by_volume"]], "dials.algorithms.indexing.model_evaluation.Result": [[11, 5, 1, "", "crystal"], [11, 5, 1, "", "fraction_indexed"], [11, 5, 1, "", "hkl_offset"], [11, 5, 1, "", "model_likelihood"], [11, 5, 1, "", "n_indexed"], [11, 5, 1, "", "rmsds"]], "dials.algorithms.indexing.model_evaluation.Strategy": [[11, 2, 1, "", "evaluate"]], "dials.algorithms.indexing.nearest_neighbor": [[11, 1, 1, "", "NeighborAnalysis"]], "dials.algorithms.indexing.nearest_neighbor.NeighborAnalysis": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "plot_histogram"]], "dials.algorithms.indexing.refinement": [[11, 3, 1, "", "refine"]], "dials.algorithms.indexing.stills_indexer": [[11, 1, 1, "", "StillsIndexer"], [11, 1, 1, "", "StillsIndexerBasisVectorSearch"], [11, 1, 1, "", "StillsIndexerKnownOrientation"], [11, 1, 1, "", "StillsIndexerLatticeSearch"], [11, 3, 1, "", "calc_2D_rmsd_and_displacements"], [11, 3, 1, "", "e_refine"], [11, 3, 1, "", "plot_displacements"]], "dials.algorithms.indexing.stills_indexer.StillsIndexer": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "choose_best_orientation_matrix"], [11, 2, 1, "", "experiment_list_for_crystal"], [11, 2, 1, "", "identify_outliers"], [11, 2, 1, "", "index"], [11, 2, 1, "", "refine"], [11, 2, 1, "", "warn_if_setting_unused_refinement_protocol_params"]], "dials.algorithms.indexing.symmetry": [[11, 1, 1, "", "SymmetryHandler"], [11, 3, 1, "", "calc_acentric_subgroups"], [11, 3, 1, "", "find_matching_symmetry"], [11, 3, 1, "", "groups_cache"], [11, 3, 1, "", "metric_supergroup"]], "dials.algorithms.indexing.symmetry.SymmetryHandler": [[11, 2, 1, "", "__init__"], [11, 2, 1, "", "apply_symmetry"]], "dials.algorithms.integration": [[12, 0, 0, "-", "integrator"]], "dials.algorithms.integration.integrator": [[12, 1, 1, "", "Executor"], [12, 1, 1, "", "Integrator"], [12, 1, 1, "", "Integrator2D"], [12, 1, 1, "", "Integrator3D"], [12, 1, 1, "", "Integrator3DThreaded"], [12, 1, 1, "", "IntegratorExecutor"], [12, 1, 1, "", "IntegratorFlat3D"], [12, 1, 1, "", "IntegratorSingle2D"], [12, 1, 1, "", "IntegratorStills"], [12, 1, 1, "", "JobList"], [12, 1, 1, "", "Parameters"], [12, 1, 1, "", "Processor2D"], [12, 1, 1, "", "Processor3D"], [12, 1, 1, "", "ProcessorFlat3D"], [12, 1, 1, "", "ProcessorSingle2D"], [12, 1, 1, "", "ProcessorStills"], [12, 1, 1, "", "ProfileModellerExecutor"], [12, 1, 1, "", "ProfileValidatorExecutor"], [12, 1, 1, "", "ReflectionManager"], [12, 3, 1, "", "frame_hist"], [12, 3, 1, "", "generate_phil_scope"], [12, 3, 1, "", "hist"], [12, 3, 1, "", "nframes_hist"]], "dials.algorithms.integration.integrator.Executor": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "process"]], "dials.algorithms.integration.integrator.Integrator": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "fit_profiles"], [12, 2, 1, "", "integrate"], [12, 2, 1, "", "report"], [12, 2, 1, "", "summary"]], "dials.algorithms.integration.integrator.Integrator2D": [[12, 5, 1, "", "ProcessorClass"], [12, 2, 1, "", "finalize_reflections"], [12, 2, 1, "", "initialize_reflections"]], "dials.algorithms.integration.integrator.Integrator3D": [[12, 5, 1, "", "ProcessorClass"], [12, 2, 1, "", "finalize_reflections"], [12, 2, 1, "", "initialize_reflections"]], "dials.algorithms.integration.integrator.Integrator3DThreaded": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "finalise"], [12, 2, 1, "", "initialise"], [12, 2, 1, "", "integrate"], [12, 2, 1, "", "report"], [12, 2, 1, "", "summary"]], "dials.algorithms.integration.integrator.IntegratorExecutor": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "data"], [12, 2, 1, "", "finalize"], [12, 2, 1, "", "initialize"], [12, 2, 1, "", "process"]], "dials.algorithms.integration.integrator.IntegratorFlat3D": [[12, 5, 1, "", "ProcessorClass"], [12, 2, 1, "", "finalize_reflections"], [12, 2, 1, "", "initialize_reflections"]], "dials.algorithms.integration.integrator.IntegratorSingle2D": [[12, 5, 1, "", "ProcessorClass"], [12, 2, 1, "", "finalize_reflections"], [12, 2, 1, "", "initialize_reflections"]], "dials.algorithms.integration.integrator.IntegratorStills": [[12, 5, 1, "", "ProcessorClass"], [12, 2, 1, "", "finalize_reflections"], [12, 2, 1, "", "initialize_reflections"]], "dials.algorithms.integration.integrator.JobList": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "add"], [12, 2, 1, "", "shoebox_memory"], [12, 2, 1, "", "split"]], "dials.algorithms.integration.integrator.Parameters": [[12, 1, 1, "", "Filter"], [12, 1, 1, "", "Profile"], [12, 2, 1, "", "__init__"], [12, 2, 1, "", "from_phil"]], "dials.algorithms.integration.integrator.Parameters.Filter": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.Parameters.Profile": [[12, 1, 1, "", "Validation"], [12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.Parameters.Profile.Validation": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.Processor2D": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.Processor3D": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.ProcessorFlat3D": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.ProcessorSingle2D": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.ProcessorStills": [[12, 2, 1, "", "__init__"]], "dials.algorithms.integration.integrator.ProfileModellerExecutor": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "data"], [12, 2, 1, "", "finalize"], [12, 2, 1, "", "initialize"], [12, 2, 1, "", "process"]], "dials.algorithms.integration.integrator.ProfileValidatorExecutor": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "data"], [12, 2, 1, "", "finalize"], [12, 2, 1, "", "initialize"], [12, 2, 1, "", "process"]], "dials.algorithms.integration.integrator.ReflectionManager": [[12, 2, 1, "", "__init__"], [12, 2, 1, "", "accumulate"], [12, 2, 1, "", "data"], [12, 2, 1, "", "finished"], [12, 2, 1, "", "job"], [12, 2, 1, "", "num_reflections"], [12, 2, 1, "", "split"]], "dials.algorithms.refinement": [[14, 0, 0, "-", "engine"], [14, 0, 0, "-", "refiner"], [14, 0, 0, "-", "reflection_manager"], [14, 0, 0, "-", "target"], [14, 0, 0, "-", "target_stills"], [14, 0, 0, "-", "weighting_strategies"]], "dials.algorithms.refinement.engine": [[14, 1, 1, "", "AdaptLbfgs"], [14, 1, 1, "", "AdaptLstbx"], [14, 1, 1, "", "DisableMPmixin"], [14, 1, 1, "", "GaussNewtonIterations"], [14, 1, 1, "", "Journal"], [14, 1, 1, "", "LBFGScurvs"], [14, 1, 1, "", "LevenbergMarquardtIterations"], [14, 1, 1, "", "Refinery"], [14, 1, 1, "", "SimpleLBFGS"]], "dials.algorithms.refinement.engine.AdaptLbfgs": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "callback_after_step"], [14, 2, 1, "", "compute_functional_and_gradients"], [14, 2, 1, "", "compute_functional_gradients_and_curvatures"], [14, 2, 1, "", "run_lbfgs"]], "dials.algorithms.refinement.engine.AdaptLstbx": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "build_up"], [14, 2, 1, "", "calculate_esds"], [14, 2, 1, "", "parameter_vector_norm"], [14, 2, 1, "", "restart"], [14, 2, 1, "", "set_cholesky_factor"], [14, 2, 1, "", "step_backward"], [14, 2, 1, "", "step_forward"]], "dials.algorithms.refinement.engine.DisableMPmixin": [[14, 2, 1, "", "set_nproc"]], "dials.algorithms.refinement.engine.GaussNewtonIterations": [[14, 2, 1, "", "__init__"], [14, 5, 1, "", "convergence_as_shift_over_esd"], [14, 5, 1, "", "damping_value"], [14, 5, 1, "", "gradient_threshold"], [14, 5, 1, "", "max_shift_over_esd"], [14, 2, 1, "", "run"], [14, 5, 1, "", "step_threshold"]], "dials.algorithms.refinement.engine.Journal": [[14, 2, 1, "", "add_column"], [14, 2, 1, "", "add_row"], [14, 2, 1, "", "del_last_row"], [14, 2, 1, "", "from_json_file"], [14, 2, 1, "", "get_nrows"], [14, 5, 1, "", "reason_for_termination"], [14, 2, 1, "", "set_last_cell"], [14, 2, 1, "", "to_json_file"]], "dials.algorithms.refinement.engine.LBFGScurvs": [[14, 2, 1, "", "compute_functional_gradients_diag"], [14, 2, 1, "", "run"]], "dials.algorithms.refinement.engine.LevenbergMarquardtIterations": [[14, 2, 1, "", "add_constant_to_diagonal"], [14, 6, 1, "", "mu"], [14, 2, 1, "", "report_progress"], [14, 2, 1, "", "run"], [14, 2, 1, "", "setup_mu"], [14, 5, 1, "", "tau"]], "dials.algorithms.refinement.engine.Refinery": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "get_correlation_matrix_for_step"], [14, 2, 1, "", "get_num_steps"], [14, 2, 1, "", "jacobian_condition_number"], [14, 2, 1, "", "prepare_for_step"], [14, 2, 1, "", "run"], [14, 2, 1, "", "set_nproc"], [14, 2, 1, "", "split_jacobian_into_blocks"], [14, 2, 1, "", "test_for_termination"], [14, 2, 1, "", "test_objective_increasing_but_not_nref"], [14, 2, 1, "", "test_rmsd_convergence"], [14, 2, 1, "", "update_journal"]], "dials.algorithms.refinement.engine.SimpleLBFGS": [[14, 2, 1, "", "run"]], "dials.algorithms.refinement.refiner": [[14, 1, 1, "", "Refiner"], [14, 1, 1, "", "RefinerFactory"], [14, 1, 1, "", "ScanVaryingRefiner"]], "dials.algorithms.refinement.refiner.Refiner": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "calc_exp_rmsd_table"], [14, 2, 1, "", "get_experiments"], [14, 2, 1, "", "get_free_reflections"], [14, 2, 1, "", "get_matches"], [14, 2, 1, "", "get_param_reporter"], [14, 2, 1, "", "get_parameter_correlation_matrix"], [14, 6, 1, "", "history"], [14, 2, 1, "", "predict_for_indexed"], [14, 2, 1, "", "predict_for_reflection_table"], [14, 2, 1, "", "print_exp_rmsd_table"], [14, 2, 1, "", "print_out_of_sample_rmsd_table"], [14, 2, 1, "", "print_panel_rmsd_table"], [14, 2, 1, "", "print_step_table"], [14, 2, 1, "", "rmsds"], [14, 2, 1, "", "rmsds_for_reflection_table"], [14, 2, 1, "", "run"], [14, 2, 1, "", "selection_used_for_refinement"]], "dials.algorithms.refinement.refiner.RefinerFactory": [[14, 2, 1, "", "config_refinery"], [14, 2, 1, "", "config_restraints"], [14, 2, 1, "", "config_sparse"], [14, 2, 1, "", "config_target"], [14, 2, 1, "", "from_parameters_data_experiments"], [14, 2, 1, "", "reflections_after_outlier_rejection"]], "dials.algorithms.refinement.reflection_manager": [[14, 1, 1, "", "BlockCalculator"], [14, 1, 1, "", "LaueReflectionManager"], [14, 1, 1, "", "ReflectionManager"], [14, 1, 1, "", "ReflectionManagerFactory"], [14, 1, 1, "", "StillsReflectionManager"], [14, 1, 1, "", "TOFReflectionManager"]], "dials.algorithms.refinement.reflection_manager.BlockCalculator": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "per_image"], [14, 2, 1, "", "per_width"]], "dials.algorithms.refinement.reflection_manager.LaueReflectionManager": [[14, 2, 1, "", "__init__"], [14, 5, 1, "", "experiment_type"], [14, 2, 1, "", "print_stats_on_matches"], [14, 2, 1, "", "update_residuals"]], "dials.algorithms.refinement.reflection_manager.ReflectionManager": [[14, 2, 1, "", "__init__"], [14, 5, 1, "", "experiment_type"], [14, 2, 1, "", "filter_obs"], [14, 2, 1, "", "finalise"], [14, 2, 1, "", "get_accepted_refs_size"], [14, 2, 1, "", "get_centroid_analyser"], [14, 2, 1, "", "get_free_reflections"], [14, 2, 1, "", "get_indexed"], [14, 2, 1, "", "get_matches"], [14, 2, 1, "", "get_obs"], [14, 2, 1, "", "get_sample_size"], [14, 2, 1, "", "print_stats_on_matches"], [14, 2, 1, "", "reset_accepted_reflections"], [14, 2, 1, "", "update_residuals"]], "dials.algorithms.refinement.reflection_manager.ReflectionManagerFactory": [[14, 2, 1, "", "from_parameters_reflections_experiments"], [14, 2, 1, "", "get_weighting_strategy_override"], [14, 2, 1, "", "laue_manager"], [14, 2, 1, "", "rotation_scan_manager"], [14, 2, 1, "", "stills_manager"]], "dials.algorithms.refinement.reflection_manager.StillsReflectionManager": [[14, 5, 1, "", "experiment_type"], [14, 2, 1, "", "print_stats_on_matches"]], "dials.algorithms.refinement.reflection_manager.TOFReflectionManager": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "update_residuals"]], "dials.algorithms.refinement.target": [[14, 1, 1, "", "LaueLeastSquaresResidualWithRmsdCutoff"], [14, 1, 1, "", "LeastSquaresPositionalResidualWithRmsdCutoff"], [14, 1, 1, "", "LeastSquaresPositionalResidualWithRmsdCutoffSparse"], [14, 1, 1, "", "SparseGradientsMixin"], [14, 1, 1, "", "TOFLeastSquaresResidualWithRmsdCutoff"], [14, 1, 1, "", "Target"], [14, 1, 1, "", "TargetFactory"]], "dials.algorithms.refinement.target.LaueLeastSquaresResidualWithRmsdCutoff": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "achieved"], [14, 5, 1, "", "rmsd_names"], [14, 5, 1, "", "rmsd_units"]], "dials.algorithms.refinement.target.LeastSquaresPositionalResidualWithRmsdCutoff": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "achieved"]], "dials.algorithms.refinement.target.TOFLeastSquaresResidualWithRmsdCutoff": [[14, 5, 1, "", "rmsd_names"], [14, 5, 1, "", "rmsd_units"]], "dials.algorithms.refinement.target.Target": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "achieved"], [14, 2, 1, "", "calculate_gradients"], [14, 2, 1, "", "compute_functional_gradients_and_curvatures"], [14, 2, 1, "", "compute_residuals"], [14, 2, 1, "", "compute_residuals_and_gradients"], [14, 2, 1, "", "compute_restraints_functional_gradients_and_curvatures"], [14, 2, 1, "", "compute_restraints_residuals_and_gradients"], [14, 6, 1, "", "dim"], [14, 2, 1, "", "get_num_matches"], [14, 2, 1, "", "get_num_matches_for_experiment"], [14, 2, 1, "", "get_num_matches_for_panel"], [14, 2, 1, "", "predict"], [14, 2, 1, "", "predict_for_free_reflections"], [14, 2, 1, "", "predict_for_reflection_table"], [14, 5, 1, "", "rmsd_names"], [14, 5, 1, "", "rmsd_units"], [14, 2, 1, "", "rmsds"], [14, 2, 1, "", "rmsds_for_experiment"], [14, 2, 1, "", "rmsds_for_panel"], [14, 2, 1, "", "rmsds_for_reflection_table"], [14, 2, 1, "", "split_matches_into_blocks"], [14, 2, 1, "", "update_matches"]], "dials.algorithms.refinement.target.TargetFactory": [[14, 2, 1, "", "from_parameters_and_experiments"]], "dials.algorithms.refinement.target_stills": [[14, 1, 1, "", "LeastSquaresStillsResidualWithRmsdCutoff"], [14, 1, 1, "", "LeastSquaresStillsResidualWithRmsdCutoffSparse"]], "dials.algorithms.refinement.target_stills.LeastSquaresStillsResidualWithRmsdCutoff": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "achieved"], [14, 2, 1, "", "predict_for_reflection_table"], [14, 5, 1, "", "rmsd_names"], [14, 5, 1, "", "rmsd_units"]], "dials.algorithms.refinement.weighting_strategies": [[14, 1, 1, "", "ConstantWeightingStrategy"], [14, 1, 1, "", "ExternalDelPsiWeightingStrategy"], [14, 1, 1, "", "LaueMixedWeightingStrategy"], [14, 1, 1, "", "LaueStatisticalWeightingStrategy"], [14, 1, 1, "", "StatisticalWeightingStrategy"], [14, 1, 1, "", "StillsWeightingStrategy"]], "dials.algorithms.refinement.weighting_strategies.ConstantWeightingStrategy": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "calculate_weights"]], "dials.algorithms.refinement.weighting_strategies.ExternalDelPsiWeightingStrategy": [[14, 2, 1, "", "calculate_weights"]], "dials.algorithms.refinement.weighting_strategies.LaueMixedWeightingStrategy": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "calculate_weights"]], "dials.algorithms.refinement.weighting_strategies.LaueStatisticalWeightingStrategy": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "calculate_weights"]], "dials.algorithms.refinement.weighting_strategies.StatisticalWeightingStrategy": [[14, 2, 1, "", "calculate_weights"]], "dials.algorithms.refinement.weighting_strategies.StillsWeightingStrategy": [[14, 2, 1, "", "__init__"], [14, 2, 1, "", "calculate_weights"]], "dials.algorithms.scaling": [[15, 0, 0, "-", "outlier_rejection"]], "dials.algorithms.scaling.model": [[15, 0, 0, "-", "model"]], "dials.algorithms.scaling.model.model": [[15, 1, 1, "", "ArrayScalingModel"], [15, 1, 1, "", "DoseDecay"], [15, 1, 1, "", "KBScalingModel"], [15, 1, 1, "", "PhysicalScalingModel"], [15, 1, 1, "", "ScalingModelBase"], [15, 3, 1, "", "calc_n_param_from_bins"], [15, 3, 1, "", "calculate_new_offset"], [15, 3, 1, "", "determine_auto_absorption_params"], [15, 3, 1, "", "initialise_smooth_input"], [15, 3, 1, "", "make_combined_plots"], [15, 3, 1, "", "plot_scaling_models"]], "dials.algorithms.scaling.model.model.ArrayScalingModel": [[15, 2, 1, "", "__init__"], [15, 2, 1, "", "configure_components"], [15, 6, 1, "", "consecutive_refinement_order"], [15, 2, 1, "", "from_data"], [15, 2, 1, "", "from_dict"], [15, 5, 1, "", "id_"], [15, 2, 1, "", "limit_image_range"], [15, 5, 1, "", "phil_scope"], [15, 2, 1, "", "plot_model_components"], [15, 2, 1, "", "update"]], "dials.algorithms.scaling.model.model.DoseDecay": [[15, 2, 1, "", "__init__"], [15, 2, 1, "", "configure_components"], [15, 6, 1, "", "consecutive_refinement_order"], [15, 2, 1, "", "fix_initial_parameter"], [15, 2, 1, "", "from_data"], [15, 2, 1, "", "from_dict"], [15, 2, 1, "", "get_shared_components"], [15, 5, 1, "", "id_"], [15, 2, 1, "", "limit_image_range"], [15, 5, 1, "", "phil_scope"], [15, 2, 1, "", "plot_model_components"], [15, 2, 1, "", "update"]], "dials.algorithms.scaling.model.model.KBScalingModel": [[15, 2, 1, "", "__init__"], [15, 2, 1, "", "configure_components"], [15, 6, 1, "", "consecutive_refinement_order"], [15, 2, 1, "", "from_data"], [15, 2, 1, "", "from_dict"], [15, 5, 1, "", "id_"], [15, 5, 1, "", "phil_scope"], [15, 2, 1, "", "update"]], "dials.algorithms.scaling.model.model.PhysicalScalingModel": [[15, 2, 1, "", "__init__"], [15, 2, 1, "", "configure_components"], [15, 6, 1, "", "consecutive_refinement_order"], [15, 2, 1, "", "fix_initial_parameter"], [15, 2, 1, "", "from_data"], [15, 2, 1, "", "from_dict"], [15, 2, 1, "", "get_shared_components"], [15, 5, 1, "", "id_"], [15, 2, 1, "", "limit_image_range"], [15, 5, 1, "", "phil_scope"], [15, 2, 1, "", "plot_model_components"], [15, 2, 1, "", "update"]], "dials.algorithms.scaling.model.model.ScalingModelBase": [[15, 2, 1, "", "__init__"], [15, 6, 1, "", "components"], [15, 6, 1, "", "configdict"], [15, 2, 1, "", "configure_components"], [15, 2, 1, "", "consecutive_refinement_order"], [15, 6, 1, "", "error_model"], [15, 2, 1, "", "fix_initial_parameter"], [15, 6, 1, "", "fixed_components"], [15, 2, 1, "", "from_data"], [15, 2, 1, "", "from_dict"], [15, 2, 1, "", "get_shared_components"], [15, 5, 1, "", "id_"], [15, 6, 1, "", "is_scaled"], [15, 2, 1, "", "limit_image_range"], [15, 2, 1, "", "load_error_model"], [15, 6, 1, "", "n_params"], [15, 2, 1, "", "plot_model_components"], [15, 2, 1, "", "record_intensity_combination_Imid"], [15, 2, 1, "", "set_error_model"], [15, 2, 1, "", "set_scaling_model_as_scaled"], [15, 2, 1, "", "set_scaling_model_as_unscaled"], [15, 2, 1, "", "set_valid_image_range"], [15, 2, 1, "", "to_dict"], [15, 2, 1, "", "update"]], "dials.algorithms.scaling.outlier_rejection": [[15, 1, 1, "", "NormDevOutlierRejection"], [15, 1, 1, "", "OutlierRejectionBase"], [15, 1, 1, "", "SimpleNormDevOutlierRejection"], [15, 1, 1, "", "TargetedOutlierRejection"], [15, 3, 1, "", "determine_Esq_outlier_index_arrays"], [15, 3, 1, "", "determine_outlier_index_arrays"], [15, 3, 1, "", "reject_outliers"]], "dials.algorithms.scaling.outlier_rejection.NormDevOutlierRejection": [[15, 2, 1, "", "__init__"]], "dials.algorithms.scaling.outlier_rejection.OutlierRejectionBase": [[15, 2, 1, "", "__init__"], [15, 5, 1, "", "final_outlier_arrays"], [15, 2, 1, "", "run"]], "dials.algorithms.scaling.outlier_rejection.SimpleNormDevOutlierRejection": [[15, 2, 1, "", "__init__"]], "dials.algorithms.scaling.outlier_rejection.TargetedOutlierRejection": [[15, 2, 1, "", "__init__"]], "dials.algorithms.spot_finding": [[16, 0, 0, "-", "factory"], [16, 0, 0, "-", "finder"]], "dials.algorithms.spot_finding.factory": [[16, 1, 1, "", "BackgroundGradientFilter"], [16, 1, 1, "", "FilterRunner"], [16, 1, 1, "", "PeakCentroidDistanceFilter"], [16, 1, 1, "", "SpotDensityFilter"], [16, 1, 1, "", "SpotFinderFactory"], [16, 3, 1, "", "generate_phil_scope"]], "dials.algorithms.spot_finding.factory.BackgroundGradientFilter": [[16, 2, 1, "", "__init__"], [16, 2, 1, "", "run"]], "dials.algorithms.spot_finding.factory.FilterRunner": [[16, 2, 1, "", "__init__"], [16, 2, 1, "", "check_flags"]], "dials.algorithms.spot_finding.factory.PeakCentroidDistanceFilter": [[16, 2, 1, "", "__init__"], [16, 2, 1, "", "run"]], "dials.algorithms.spot_finding.factory.SpotDensityFilter": [[16, 2, 1, "", "__init__"], [16, 2, 1, "", "run"]], "dials.algorithms.spot_finding.factory.SpotFinderFactory": [[16, 2, 1, "", "configure_filter"], [16, 2, 1, "", "configure_threshold"], [16, 2, 1, "", "from_parameters"], [16, 2, 1, "", "load_image"]], "dials.algorithms.spot_finding.finder": [[16, 1, 1, "", "ExtractPixelsFromImage"], [16, 1, 1, "", "ExtractPixelsFromImage2DNoShoeboxes"], [16, 1, 1, "", "ExtractSpots"], [16, 1, 1, "", "ExtractSpotsParallelTask"], [16, 1, 1, "", "SpotFinder"], [16, 1, 1, "", "TOFSpotFinder"], [16, 3, 1, "", "pixel_list_to_reflection_table"], [16, 3, 1, "", "pixel_list_to_shoeboxes"], [16, 3, 1, "", "shoeboxes_to_reflection_table"]], "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage": [[16, 2, 1, "", "__init__"]], "dials.algorithms.spot_finding.finder.ExtractPixelsFromImage2DNoShoeboxes": [[16, 2, 1, "", "__init__"]], "dials.algorithms.spot_finding.finder.ExtractSpots": [[16, 2, 1, "", "__init__"]], "dials.algorithms.spot_finding.finder.ExtractSpotsParallelTask": [[16, 2, 1, "", "__init__"]], "dials.algorithms.spot_finding.finder.SpotFinder": [[16, 2, 1, "", "__init__"], [16, 2, 1, "", "find_spots"]], "dials.algorithms.spot_finding.finder.TOFSpotFinder": [[16, 2, 1, "", "__init__"]], "dials.algorithms.spot_prediction": [[17, 0, 0, "-", "reflection_predictor"]], "dials.algorithms.spot_prediction.reflection_predictor": [[17, 1, 1, "", "ReflectionPredictor"]], "dials.algorithms.spot_prediction.reflection_predictor.ReflectionPredictor": [[17, 2, 1, "", "__init__"], [17, 2, 1, "", "predictor"]], "dials.algorithms.symmetry": [[18, 0, 0, "-", "cosym"], [18, 0, 0, "-", "laue_group"], [18, 3, 1, "", "median_unit_cell"], [18, 0, 0, "-", "reindex_to_reference"], [18, 3, 1, "", "resolution_filter_from_array"], [18, 3, 1, "", "resolution_filter_from_reflections_experiments"], [18, 1, 1, "", "symmetry_base"]], "dials.algorithms.symmetry.cosym": [[18, 1, 1, "", "CosymAnalysis"], [18, 1, 1, "", "ScoreSubGroup"], [18, 1, 1, "", "ScoreSymmetryElement"], [18, 1, 1, "", "SymmetryAnalysis"], [18, 3, 1, "", "change_of_basis_op_to_best_cell"], [18, 0, 0, "-", "engine"], [18, 3, 1, "", "extract_reference_intensities"], [18, 0, 0, "-", "target"]], "dials.algorithms.symmetry.cosym.CosymAnalysis": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"], [18, 2, 1, "", "as_json"], [18, 2, 1, "", "run"]], "dials.algorithms.symmetry.cosym.ScoreSubGroup": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"], [18, 6, 1, "", "stars"]], "dials.algorithms.symmetry.cosym.ScoreSymmetryElement": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"], [18, 6, 1, "", "stars"]], "dials.algorithms.symmetry.cosym.SymmetryAnalysis": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"], [18, 2, 1, "", "subgroups_table"], [18, 2, 1, "", "summary_table"], [18, 2, 1, "", "sym_ops_table"]], "dials.algorithms.symmetry.cosym.engine": [[18, 1, 1, "", "lbfgs_with_curvs"], [18, 3, 1, "", "minimize_scipy"], [18, 3, 1, "", "minimize_scitbx_lbfgs"]], "dials.algorithms.symmetry.cosym.engine.lbfgs_with_curvs": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "callback_after_step"], [18, 2, 1, "", "compute_functional_and_gradients"], [18, 2, 1, "", "compute_functional_gradients_and_curvatures"], [18, 2, 1, "", "compute_functional_gradients_diag"]], "dials.algorithms.symmetry.cosym.target": [[18, 1, 1, "", "Target"]], "dials.algorithms.symmetry.cosym.target.Target": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "compute_functional"], [18, 2, 1, "", "compute_gradients"], [18, 2, 1, "", "compute_gradients_fd"], [18, 2, 1, "", "curvatures"], [18, 2, 1, "", "curvatures_fd"], [18, 5, 1, "", "dim"], [18, 2, 1, "", "set_dimensions"]], "dials.algorithms.symmetry.laue_group": [[18, 1, 1, "", "CorrelationCoefficientAccumulator"], [18, 1, 1, "", "LaueGroupAnalysis"], [18, 1, 1, "", "ScoreCorrelationCoefficient"], [18, 1, 1, "", "ScoreSubGroup"], [18, 1, 1, "", "ScoreSymmetryElement"], [18, 3, 1, "", "trunccauchy_pdf"]], "dials.algorithms.symmetry.laue_group.CorrelationCoefficientAccumulator": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "accumulate"], [18, 2, 1, "", "coefficient"], [18, 2, 1, "", "denominator"], [18, 2, 1, "", "n"], [18, 2, 1, "", "numerator"]], "dials.algorithms.symmetry.laue_group.LaueGroupAnalysis": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"], [18, 2, 1, "", "as_json"]], "dials.algorithms.symmetry.laue_group.ScoreCorrelationCoefficient": [[18, 2, 1, "", "__init__"], [18, 6, 1, "", "p_cc_given_not_s"], [18, 6, 1, "", "p_cc_given_s"], [18, 6, 1, "", "p_s_given_cc"]], "dials.algorithms.symmetry.laue_group.ScoreSubGroup": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"]], "dials.algorithms.symmetry.laue_group.ScoreSymmetryElement": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "as_dict"]], "dials.algorithms.symmetry.reindex_to_reference": [[18, 3, 1, "", "determine_reindex_operator_against_reference"]], "dials.algorithms.symmetry.symmetry_base": [[18, 2, 1, "", "__init__"], [18, 2, 1, "", "kernel_normalisation"], [18, 2, 1, "", "ml_aniso_normalisation"], [18, 2, 1, "", "ml_iso_normalisation"]], "dials.array_family": [[20, 0, 0, "-", "flex"]], "dials.extensions": [[31, 0, 0, "-", "dispersion_spotfinder_threshold_ext"], [31, 0, 0, "-", "gaussian_rs_profile_model_ext"], [31, 0, 0, "-", "null_background_ext"], [31, 0, 0, "-", "simple_background_ext"], [31, 0, 0, "-", "simple_centroid_ext"]], "dials.extensions.dispersion_spotfinder_threshold_ext": [[31, 1, 1, "", "DispersionSpotFinderThresholdExt"], [31, 3, 1, "", "estimate_global_threshold"]], "dials.extensions.dispersion_spotfinder_threshold_ext.DispersionSpotFinderThresholdExt": [[31, 2, 1, "", "__init__"], [31, 2, 1, "", "compute_threshold"], [31, 5, 1, "", "name"], [31, 2, 1, "", "phil"]], "dials.extensions.gaussian_rs_profile_model_ext": [[31, 1, 1, "", "GaussianRSProfileModelExt"]], "dials.extensions.gaussian_rs_profile_model_ext.GaussianRSProfileModelExt": [[31, 2, 1, "", "algorithm"], [31, 5, 1, "", "default"], [31, 2, 1, "", "from_dict"], [31, 5, 1, "", "name"], [31, 2, 1, "", "phil"]], "dials.extensions.null_background_ext": [[31, 1, 1, "", "NullBackgroundExt"]], "dials.extensions.null_background_ext.NullBackgroundExt": [[31, 2, 1, "", "__init__"], [31, 2, 1, "", "compute_background"], [31, 5, 1, "", "name"]], "dials.extensions.simple_background_ext": [[31, 1, 1, "", "SimpleBackgroundExt"]], "dials.extensions.simple_background_ext.SimpleBackgroundExt": [[31, 2, 1, "", "__init__"], [31, 2, 1, "", "compute_background"], [31, 5, 1, "", "name"], [31, 2, 1, "", "phil"]], "dials.extensions.simple_centroid_ext": [[31, 1, 1, "", "SimpleCentroidExt"]], "dials.extensions.simple_centroid_ext.SimpleCentroidExt": [[31, 2, 1, "", "__init__"], [31, 2, 1, "", "compute_centroid"], [31, 5, 1, "", "default"], [31, 5, 1, "", "name"]], "dials.util": [[33, 0, 0, "-", "command_line"], [33, 0, 0, "-", "export_mtz"], [33, 0, 0, "-", "export_text"], [33, 0, 0, "-", "image"], [33, 0, 0, "-", "installer"], [33, 0, 0, "-", "ioutil"], [33, 0, 0, "-", "nexus"], [33, 0, 0, "-", "options"]], "dials.util.command_line": [[33, 1, 1, "", "Command"], [33, 1, 1, "", "ProgressBar"], [33, 1, 1, "", "ProgressBarTimer"], [33, 3, 1, "", "coloured"], [33, 3, 1, "", "heading"]], "dials.util.command_line.Command": [[33, 2, 1, "", "end"], [33, 5, 1, "", "indent"], [33, 5, 1, "", "max_length"], [33, 5, 1, "", "print_time"], [33, 2, 1, "", "start"]], "dials.util.command_line.ProgressBar": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "finished"], [33, 2, 1, "", "update"]], "dials.util.command_line.ProgressBarTimer": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "get_elapsed_time"], [33, 2, 1, "", "update"]], "dials.util.export_mtz": [[33, 1, 1, "", "MADMergedMTZWriter"], [33, 1, 1, "", "MTZWriterBase"], [33, 1, 1, "", "MergedMTZWriter"], [33, 1, 1, "", "WavelengthGroup"], [33, 3, 1, "", "add_batch_list"], [33, 3, 1, "", "convert_to_cambridge"], [33, 3, 1, "", "export_mtz"], [33, 3, 1, "", "log_summary"], [33, 3, 1, "", "match_wavelengths"], [33, 3, 1, "", "rotate_crystal"], [33, 3, 1, "", "write_columns"]], "dials.util.export_mtz.MADMergedMTZWriter": [[33, 2, 1, "", "add_dataset"]], "dials.util.export_mtz.MTZWriterBase": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "add_crystal"], [33, 2, 1, "", "add_empty_dataset"]], "dials.util.export_mtz.MergedMTZWriter": [[33, 2, 1, "", "add_dataset"]], "dials.util.export_mtz.WavelengthGroup": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "add_experiment"], [33, 2, 1, "", "calculate_weighted_mean"], [33, 5, 1, "", "exp_nos"], [33, 5, 1, "", "identifiers"], [33, 5, 1, "", "max_possible_wl"], [33, 5, 1, "", "min_wl"], [33, 5, 1, "", "wavelengths"], [33, 5, 1, "", "weighted_mean"]], "dials.util.export_text": [[33, 3, 1, "", "export_text"]], "dials.util.image": [[33, 1, 1, "", "reader"]], "dials.util.image.reader": [[33, 2, 1, "", "get_data"], [33, 2, 1, "", "read_file"]], "dials.util.installer": [[33, 1, 1, "", "installer"]], "dials.util.installer.installer": [[33, 5, 1, "", "base_package_options"], [33, 5, 1, "", "configure_modules"], [33, 5, 1, "", "dest_dir_prefix"], [33, 5, 1, "", "include_gui_packages"], [33, 5, 1, "", "installer_dir"], [33, 5, 1, "", "make_apps"], [33, 5, 1, "", "product_name"], [33, 2, 1, "", "product_specific_finalize_install"], [33, 5, 1, "", "remove_sources_default"], [33, 5, 1, "", "source_packages"]], "dials.util.ioutil": [[33, 3, 1, "", "get_inverse_ub_matrix_from_xparm"], [33, 3, 1, "", "get_space_group_type_from_xparm"]], "dials.util.nexus": [[33, 3, 1, "", "dump"], [33, 3, 1, "", "get_entry"], [33, 3, 1, "", "load"]], "dials.util.options": [[33, 1, 1, "", "ArgumentHandlingErrorInfo"], [33, 1, 1, "", "ArgumentParser"], [33, 1, 1, "", "ArgumentParserBase"], [33, 1, 1, "", "Importer"], [33, 4, 1, "", "InvalidPhilError"], [33, 1, 1, "", "OptionParser"], [33, 1, 1, "", "PhilCommandParser"], [33, 3, 1, "", "flatten_experiments"], [33, 3, 1, "", "flatten_reflections"], [33, 3, 1, "", "reflections_and_experiments_from_files"]], "dials.util.options.ArgumentHandlingErrorInfo": [[33, 5, 1, "", "exception"], [33, 5, 1, "", "message"], [33, 5, 1, "", "name"], [33, 5, 1, "", "traceback"], [33, 5, 1, "", "type"], [33, 5, 1, "", "validation"]], "dials.util.options.ArgumentParser": [[33, 2, 1, "", "__init__"], [33, 6, 1, "", "diff_phil"], [33, 2, 1, "", "format_help"], [33, 2, 1, "", "parse_args"], [33, 6, 1, "", "phil"], [33, 6, 1, "", "system_phil"]], "dials.util.options.ArgumentParserBase": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "format_epilog"], [33, 2, 1, "", "parse_known_args"]], "dials.util.options.Importer": [[33, 2, 1, "", "__init__"], [33, 2, 1, "", "try_read_experiments"], [33, 2, 1, "", "try_read_experiments_from_images"], [33, 2, 1, "", "try_read_reflections"]], "dials.util.options.OptionParser": [[33, 2, 1, "", "__init__"]], "dials.util.options.PhilCommandParser": [[33, 2, 1, "", "__init__"], [33, 6, 1, "", "diff_phil"], [33, 2, 1, "", "parse_args"], [33, 6, 1, "", "phil"], [33, 6, 1, "", "system_phil"]], "dxtbx": [[26, 0, 0, "-", "imageset"]], "dxtbx.imageset": [[26, 1, 1, "", "ExternalLookup"], [26, 1, 1, "", "ExternalLookupItemBool"], [26, 1, 1, "", "ExternalLookupItemDouble"], [26, 1, 1, "", "ImageGrid"], [26, 1, 1, "", "ImageSequence"], [26, 1, 1, "", "ImageSet"], [26, 1, 1, "", "ImageSetData"], [26, 1, 1, "", "ImageSetFactory"], [26, 1, 1, "", "ImageSetLazy"], [26, 1, 1, "", "MemReader"]], "dxtbx.imageset.ExternalLookup": [[26, 2, 1, "", "__init__"], [26, 6, 1, "", "dx"], [26, 6, 1, "", "dy"], [26, 6, 1, "", "gain"], [26, 6, 1, "", "mask"], [26, 6, 1, "", "pedestal"]], "dxtbx.imageset.ExternalLookupItemBool": [[26, 2, 1, "", "__init__"], [26, 6, 1, "", "data"], [26, 6, 1, "", "filename"]], "dxtbx.imageset.ExternalLookupItemDouble": [[26, 2, 1, "", "__init__"], [26, 6, 1, "", "data"], [26, 6, 1, "", "filename"]], "dxtbx.imageset.ImageGrid": [[26, 2, 1, "", "__init__"], [26, 2, 1, "", "from_imageset"], [26, 2, 1, "", "get_grid_size"]], "dxtbx.imageset.ImageSequence": [[26, 2, 1, "", "__init__"], [26, 2, 1, "", "complete_set"], [26, 2, 1, "", "get_array_range"], [26, 2, 1, "", "get_beam"], [26, 2, 1, "", "get_detector"], [26, 2, 1, "", "get_goniometer"], [26, 2, 1, "", "get_scan"], [26, 2, 1, "", "get_template"], [26, 2, 1, "", "partial_set"], [26, 2, 1, "", "set_beam"], [26, 2, 1, "", "set_detector"], [26, 2, 1, "", "set_goniometer"], [26, 2, 1, "", "set_scan"], [26, 2, 1, "", "update_detector_px_mm_data"]], "dxtbx.imageset.ImageSet": [[26, 2, 1, "", "__init__"], [26, 2, 1, "", "as_imageset"], [26, 2, 1, "", "clear_cache"], [26, 2, 1, "", "complete_set"], [26, 2, 1, "", "data"], [26, 6, 1, "", "external_lookup"], [26, 2, 1, "", "get_beam"], [26, 2, 1, "", "get_corrected_data"], [26, 2, 1, "", "get_detector"], [26, 2, 1, "", "get_detectorbase"], [26, 2, 1, "", "get_format_class"], [26, 2, 1, "", "get_gain"], [26, 2, 1, "", "get_goniometer"], [26, 2, 1, "", "get_image_identifier"], [26, 2, 1, "", "get_mask"], [26, 2, 1, "", "get_path"], [26, 2, 1, "", "get_pedestal"], [26, 2, 1, "", "get_raw_data"], [26, 2, 1, "", "get_scan"], [26, 2, 1, "", "get_spectrum"], [26, 2, 1, "", "get_vendortype"], [26, 2, 1, "", "has_dynamic_mask"], [26, 2, 1, "", "indices"], [26, 2, 1, "", "is_marked_for_rejection"], [26, 2, 1, "", "mark_for_rejection"], [26, 2, 1, "", "masker"], [26, 2, 1, "", "params"], [26, 2, 1, "", "partial_set"], [26, 2, 1, "", "paths"], [26, 2, 1, "", "reader"], [26, 2, 1, "", "set_beam"], [26, 2, 1, "", "set_detector"], [26, 2, 1, "", "set_goniometer"], [26, 2, 1, "", "set_scan"], [26, 2, 1, "", "size"], [26, 2, 1, "", "update_detector_px_mm_data"]], "dxtbx.imageset.ImageSetData": [[26, 2, 1, "", "__init__"], [26, 6, 1, "", "external_lookup"], [26, 2, 1, "", "get_beam"], [26, 2, 1, "", "get_data"], [26, 2, 1, "", "get_detector"], [26, 2, 1, "", "get_format_class"], [26, 2, 1, "", "get_goniometer"], [26, 2, 1, "", "get_image_identifier"], [26, 2, 1, "", "get_master_path"], [26, 2, 1, "", "get_params"], [26, 2, 1, "", "get_path"], [26, 2, 1, "", "get_scan"], [26, 2, 1, "", "get_template"], [26, 2, 1, "", "get_vendor"], [26, 2, 1, "", "has_single_file_reader"], [26, 2, 1, "", "is_marked_for_rejection"], [26, 2, 1, "", "mark_for_rejection"], [26, 2, 1, "", "masker"], [26, 2, 1, "", "partial_data"], [26, 2, 1, "", "reader"], [26, 2, 1, "", "set_beam"], [26, 2, 1, "", "set_detector"], [26, 2, 1, "", "set_format_class"], [26, 2, 1, "", "set_goniometer"], [26, 2, 1, "", "set_params"], [26, 2, 1, "", "set_scan"], [26, 2, 1, "", "set_template"], [26, 2, 1, "", "set_vendor"]], "dxtbx.imageset.ImageSetFactory": [[26, 2, 1, "", "from_template"], [26, 2, 1, "", "imageset_from_anyset"], [26, 2, 1, "", "make_imageset"], [26, 2, 1, "", "make_sequence"], [26, 2, 1, "", "new"]], "dxtbx.imageset.ImageSetLazy": [[26, 2, 1, "", "get_beam"], [26, 2, 1, "", "get_corrected_data"], [26, 2, 1, "", "get_detector"], [26, 2, 1, "", "get_gain"], [26, 2, 1, "", "get_goniometer"], [26, 2, 1, "", "get_mask"], [26, 2, 1, "", "get_scan"]], "dxtbx.imageset.MemReader": [[26, 2, 1, "", "__init__"], [26, 2, 1, "", "copy"], [26, 2, 1, "", "identifiers"], [26, 2, 1, "", "is_single_file_reader"], [26, 2, 1, "", "master_path"], [26, 2, 1, "", "paths"], [26, 2, 1, "", "read"]], "dxtbx.model": [[22, 1, 1, "", "Crystal"], [23, 1, 1, "", "Detector"], [24, 1, 1, "", "ExperimentList"], [22, 1, 1, "", "MosaicCrystalKabsch2010"], [22, 1, 1, "", "MosaicCrystalSauter2014"], [21, 0, 0, "-", "beam"], [22, 0, 0, "-", "crystal"], [23, 0, 0, "-", "detector"], [24, 0, 0, "-", "experiment_list"], [25, 0, 0, "-", "goniometer"], [28, 0, 0, "-", "profile"], [29, 0, 0, "-", "scan"]], "dxtbx.model.Crystal": [[22, 2, 1, "", "__init__"], [22, 2, 1, "", "as_str"], [22, 2, 1, "", "from_dict"], [22, 2, 1, "", "get_crystal_symmetry"], [22, 2, 1, "", "show"], [22, 2, 1, "", "to_dict"]], "dxtbx.model.Detector": [[23, 2, 1, "", "__init__"], [23, 2, 1, "", "add_group"], [23, 2, 1, "", "add_panel"], [23, 2, 1, "", "from_dict"], [23, 2, 1, "", "get_max_inscribed_resolution"], [23, 2, 1, "", "get_max_resolution"], [23, 2, 1, "", "get_names"], [23, 2, 1, "", "get_panel_intersection"], [23, 2, 1, "", "get_ray_intersection"], [23, 2, 1, "", "has_projection_2d"], [23, 2, 1, "", "hierarchy"], [23, 2, 1, "", "is_similar_to"], [23, 2, 1, "", "iter_levelorder"], [23, 2, 1, "", "iter_panels"], [23, 2, 1, "", "iter_preorder"], [23, 2, 1, "", "rotate_around_origin"], [23, 2, 1, "", "to_dict"]], "dxtbx.model.ExperimentList": [[24, 2, 1, "", "__init__"], [24, 2, 1, "", "all_laue"], [24, 2, 1, "", "all_rotations"], [24, 2, 1, "", "all_sequences"], [24, 2, 1, "", "all_stills"], [24, 2, 1, "", "all_tof"], [24, 2, 1, "", "append"], [24, 2, 1, "", "as_file"], [24, 2, 1, "", "as_json"], [24, 2, 1, "", "beams"], [24, 2, 1, "", "change_basis"], [24, 2, 1, "", "clear"], [24, 2, 1, "", "crystals"], [24, 2, 1, "", "detectors"], [24, 2, 1, "", "empty"], [24, 2, 1, "", "extend"], [24, 2, 1, "", "find"], [24, 2, 1, "", "from_file"], [24, 2, 1, "", "from_templates"], [24, 2, 1, "", "goniometers"], [24, 2, 1, "", "identifiers"], [24, 2, 1, "", "imagesets"], [24, 2, 1, "", "indices"], [24, 2, 1, "", "is_consistent"], [24, 2, 1, "", "nullify_all_single_file_reader_format_instances"], [24, 2, 1, "", "profiles"], [24, 2, 1, "", "remove_on_experiment_identifiers"], [24, 2, 1, "", "replace"], [24, 2, 1, "", "scaling_models"], [24, 2, 1, "", "scans"], [24, 2, 1, "", "select_on_experiment_identifiers"], [24, 2, 1, "", "to_dict"], [24, 2, 1, "", "where"]], "dxtbx.model.MosaicCrystalKabsch2010": [[22, 2, 1, "", "__init__"], [22, 2, 1, "", "as_str"], [22, 2, 1, "", "from_dict"], [22, 2, 1, "", "get_mosaicity"], [22, 2, 1, "", "is_similar_to"], [22, 2, 1, "", "set_mosaicity"], [22, 2, 1, "", "to_dict"]], "dxtbx.model.MosaicCrystalSauter2014": [[22, 2, 1, "", "__init__"], [22, 2, 1, "", "as_str"], [22, 2, 1, "", "from_dict"], [22, 2, 1, "", "get_A_as_sqr"], [22, 2, 1, "", "get_A_inverse_as_sqr"], [22, 2, 1, "", "get_domain_size_ang"], [22, 2, 1, "", "get_half_mosaicity_deg"], [22, 2, 1, "", "is_similar_to"], [22, 2, 1, "", "set_domain_size_ang"], [22, 2, 1, "", "set_half_mosaicity_deg"], [22, 2, 1, "", "to_dict"]], "dxtbx.model.beam": [[21, 1, 1, "", "BeamFactory"]], "dxtbx.model.beam.BeamFactory": [[21, 2, 1, "", "complex"], [21, 2, 1, "", "from_dict"], [21, 2, 1, "", "from_phil"], [21, 2, 1, "", "imgCIF"], [21, 2, 1, "", "imgCIF_H"], [21, 2, 1, "", "make_beam"], [21, 2, 1, "", "make_polarized_beam"], [21, 2, 1, "", "make_polychromatic_beam"], [21, 2, 1, "", "simple"], [21, 2, 1, "", "simple_directional"]], "dxtbx.model.crystal": [[22, 1, 1, "", "CrystalFactory"]], "dxtbx.model.crystal.CrystalFactory": [[22, 2, 1, "", "from_dict"], [22, 2, 1, "", "from_mosflm_matrix"]], "dxtbx.model.detector": [[23, 1, 1, "", "DetectorFactory"], [23, 3, 1, "", "merge_panel_scope_extracts_by_id"]], "dxtbx.model.detector.DetectorFactory": [[23, 2, 1, "", "complex"], [23, 2, 1, "", "from_dict"], [23, 2, 1, "", "from_phil"], [23, 2, 1, "", "generate_from_phil"], [23, 2, 1, "", "imgCIF"], [23, 2, 1, "", "imgCIF_H"], [23, 2, 1, "", "make_detector"], [23, 2, 1, "", "overwrite_from_phil"], [23, 2, 1, "", "sensor"], [23, 2, 1, "", "simple"], [23, 2, 1, "", "two_theta"]], "dxtbx.model.experiment_list": [[24, 1, 1, "", "BeamComparison"], [24, 1, 1, "", "DetectorComparison"], [24, 1, 1, "", "ExperimentListFactory"], [24, 1, 1, "", "GoniometerComparison"]], "dxtbx.model.experiment_list.BeamComparison": [[24, 2, 1, "", "__init__"]], "dxtbx.model.experiment_list.DetectorComparison": [[24, 2, 1, "", "__init__"]], "dxtbx.model.experiment_list.ExperimentListFactory": [[24, 2, 1, "", "from_args"], [24, 2, 1, "", "from_dict"], [24, 2, 1, "", "from_filenames"], [24, 2, 1, "", "from_imageset_and_crystal"], [24, 2, 1, "", "from_json"], [24, 2, 1, "", "from_json_file"], [24, 2, 1, "", "from_pickle_file"], [24, 2, 1, "", "from_sequence_and_crystal"], [24, 2, 1, "", "from_serialized_format"], [24, 2, 1, "", "from_stills_and_crystal"], [24, 2, 1, "", "from_templates"], [24, 2, 1, "", "from_xds"]], "dxtbx.model.experiment_list.GoniometerComparison": [[24, 2, 1, "", "__init__"]], "dxtbx.model.goniometer": [[25, 1, 1, "", "Goniometer"], [25, 1, 1, "", "GoniometerFactory"], [25, 1, 1, "", "KappaGoniometer"], [25, 1, 1, "", "MultiAxisGoniometer"]], "dxtbx.model.goniometer.Goniometer": [[25, 2, 1, "", "__init__"], [25, 2, 1, "", "from_dict"], [25, 2, 1, "", "get_fixed_rotation"], [25, 2, 1, "", "get_num_scan_points"], [25, 2, 1, "", "get_rotation_axis"], [25, 2, 1, "", "get_rotation_axis_datum"], [25, 2, 1, "", "get_setting_rotation"], [25, 2, 1, "", "get_setting_rotation_at_scan_point"], [25, 2, 1, "", "get_setting_rotation_at_scan_points"], [25, 2, 1, "", "is_similar_to"], [25, 6, 1, "", "num_scan_points"], [25, 2, 1, "", "reset_scan_points"], [25, 2, 1, "", "rotate_around_origin"], [25, 2, 1, "", "set_fixed_rotation"], [25, 2, 1, "", "set_rotation_axis"], [25, 2, 1, "", "set_rotation_axis_datum"], [25, 2, 1, "", "set_setting_rotation"], [25, 2, 1, "", "set_setting_rotation_at_scan_points"], [25, 2, 1, "", "to_dict"]], "dxtbx.model.goniometer.GoniometerFactory": [[25, 2, 1, "", "from_dict"], [25, 2, 1, "", "from_phil"], [25, 2, 1, "", "imgCIF"], [25, 2, 1, "", "imgCIF_H"], [25, 2, 1, "", "kappa"], [25, 2, 1, "", "known_axis"], [25, 2, 1, "", "make_goniometer"], [25, 2, 1, "", "make_kappa_goniometer"], [25, 2, 1, "", "make_multi_axis_goniometer"], [25, 2, 1, "", "multi_axis"], [25, 2, 1, "", "multi_axis_goniometer_from_phil"], [25, 2, 1, "", "single_axis"], [25, 2, 1, "", "single_axis_goniometer_from_phil"], [25, 2, 1, "", "single_axis_reverse"]], "dxtbx.model.goniometer.KappaGoniometer": [[25, 2, 1, "", "__init__"], [25, 2, 1, "", "get_alpha_angle"], [25, 2, 1, "", "get_direction"], [25, 2, 1, "", "get_kappa_angle"], [25, 2, 1, "", "get_kappa_axis"], [25, 2, 1, "", "get_omega_angle"], [25, 2, 1, "", "get_omega_axis"], [25, 2, 1, "", "get_phi_angle"], [25, 2, 1, "", "get_phi_axis"], [25, 2, 1, "", "get_scan_axis"]], "dxtbx.model.goniometer.MultiAxisGoniometer": [[25, 2, 1, "", "__init__"], [25, 2, 1, "", "from_dict"], [25, 2, 1, "", "get_angles"], [25, 2, 1, "", "get_axes"], [25, 2, 1, "", "get_names"], [25, 2, 1, "", "get_scan_axis"], [25, 2, 1, "", "set_angles"], [25, 2, 1, "", "set_axes"], [25, 2, 1, "", "to_dict"]], "dxtbx.model.profile": [[28, 1, 1, "", "ProfileModelFactory"]], "dxtbx.model.profile.ProfileModelFactory": [[28, 2, 1, "", "from_dict"]], "dxtbx.model.scan": [[29, 1, 1, "", "ScanFactory"]], "dxtbx.model.scan.ScanFactory": [[29, 2, 1, "", "add"], [29, 2, 1, "", "from_dict"], [29, 2, 1, "", "from_phil"], [29, 2, 1, "", "imgCIF"], [29, 2, 1, "", "imgCIF_H"], [29, 2, 1, "", "make_scan"], [29, 2, 1, "", "make_scan_from_properties"], [29, 2, 1, "", "search"], [29, 2, 1, "", "single_file"]], "dxtbx.serialize": [[30, 0, 0, "-", "imageset"], [30, 0, 0, "-", "load"], [30, 0, 0, "-", "xds"]], "dxtbx.serialize.imageset": [[30, 3, 1, "", "basic_imageset_from_dict"], [30, 3, 1, "", "basic_imageset_to_dict"], [30, 3, 1, "", "filename_or_none"], [30, 3, 1, "", "filename_to_absolute"], [30, 3, 1, "", "imagesequence_from_dict"], [30, 3, 1, "", "imagesequence_to_dict"], [30, 3, 1, "", "imageset_from_dict"], [30, 3, 1, "", "imageset_to_dict"]], "dxtbx.serialize.load": [[30, 3, 1, "", "crystal"], [30, 3, 1, "", "experiment_list"], [30, 3, 1, "", "imageset"]], "dxtbx.serialize.xds": [[30, 3, 1, "", "to_crystal"], [30, 3, 1, "", "to_imageset"], [30, 1, 1, "", "to_xds"], [30, 3, 1, "", "xds_detector_name"]], "dxtbx.serialize.xds.to_xds": [[30, 2, 1, "", "XDS_INP"], [30, 2, 1, "", "__init__"], [30, 2, 1, "", "get_beam"], [30, 2, 1, "", "get_detector"], [30, 2, 1, "", "get_goniometer"], [30, 2, 1, "", "get_scan"], [30, 2, 1, "", "get_template"], [30, 2, 1, "", "xparm_xds"]]}, "objnames": {"0": ["py", "module", "Python module"], "1": ["py", "class", "Python class"], "2": ["py", "method", "Python method"], "3": ["py", "function", "Python function"], "4": ["py", "exception", "Python exception"], "5": ["py", "attribute", "Python attribute"], "6": ["py", "property", "Python property"]}, "objtypes": {"0": "py:module", "1": "py:class", "2": "py:method", "3": "py:function", "4": "py:exception", "5": "py:attribute", "6": "py:property"}, "terms": {"": [2, 4, 6, 14, 18, 35, 43, 49, 51, 53, 54, 59, 60, 63, 70, 72, 73, 74, 76, 78, 81, 82, 83, 84, 86, 87, 88, 95], "0": [1, 2, 3, 4, 6, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 25, 26, 29, 33, 34, 35, 37, 38, 39, 40, 41, 43, 44, 45, 46, 47, 48, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 62, 63, 64, 66, 67, 68, 69, 70, 72, 73, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96], "00": [40, 42, 50, 73, 74, 76, 77, 78, 79, 81, 82, 84, 85, 86, 87, 96], "000": [40, 75, 76, 79, 81, 82, 84, 85, 86, 88], "0000": [73, 74, 78, 81, 82, 85, 86, 88], "00000": [82, 86], "00001": 74, "0001": [33, 63, 72, 82], "0001204": 81, "0001275": 86, "0001419": 81, "0001711": 86, "0001998": 82, "0002": [74, 82, 85], "000205118": 82, "0002209": 86, "000276": 81, "0002905": 82, "0003111": 86, "0003543": [], "0003546": 86, "000363": 86, "0003692": 86, "0003775": [], "000379": 86, "0003891": 86, "0004102": 86, "0004506": 86, "0004518": 81, "0004634": 86, "00047": 76, "0004804": 86, "0004832": 81, "0004946": 86, "000498": 82, "0005383": 86, "0005444": 86, "0005848": 86, "0006": 81, "00062": 76, "0006215": 86, "0006226": [], "0006477": 86, "0006649": 86, "0006705": 81, "0006723": 86, "0007": 14, "00072": 74, "0007391": 81, "0007586": 86, "0007615": [], "0007655": 81, "00078": 76, "0007897": 86, "0008": 85, "0008039": 86, "0008083": 86, "0008088": [], "0008108": 86, "0008164": 81, "000831161": 86, "00083136": [], "0008647": 81, "00087": 84, "0009": [81, 86], "0009226": 86, "0009726389448611214": 3, "001": [14, 40, 53, 59, 60, 73, 82, 84], "0010": 86, "001011": 82, "001016": 82, "00103": 86, "001032": [], "001034": 86, "00104": [73, 86], "00105738": 82, "001113": 82, "0012": [76, 86], "001238": 82, "0013": [76, 81, 82, 85], "001314": 82, "001424": 82, "001455": 82, "001485": 83, "001499": 83, "0015": 76, "001552": 82, "0016": 83, "001655": 82, "00168": 81, "00171": 82, "001733": 81, "00175": 82, "001821": 81, "00193": 86, "00196911": 82, "002": [16, 46, 47, 50, 51, 82, 84], "002058": 82, "00206": 73, "0021": [82, 84], "002108": 81, "0021159302715049923": 3, "0021250002879257116": 3, "002168": 82, "002213": 81, "002306": 82, "0025": 53, "002529": 86, "002579": 82, "0026": 82, "0027": 82, "002731": 82, "0028": 78, "002804": 82, "002887": 86, "0029": 86, "003": [73, 84], "0030": [85, 86], "00306": 82, "0032": 74, "003241": 82, "0033": 84, "00340589": 82, "00340611": 82, "0035": [81, 85, 86], "00356": 88, "0036": [40, 84, 86], "003802": 82, "0039": [40, 84, 85], "003907": 74, "004": [41, 51, 54, 58, 73, 76, 82, 84, 85], "0040": 82, "00401706": [53, 59, 60], "0041": [81, 82, 86], "00417": 73, "0042": [40, 84], "0043": [40, 84], "0044": 74, "0045": 82, "0047": [85, 86], "0048": 85, "005": [54, 73, 79, 82, 84], "0051": 74, "0052": [40, 82, 84], "0053": [74, 82, 86], "0054": [], "005551": 82, "00556521": [], "00556579": 86, "00567814": [], "00567871": 86, "005739": 81, "005742": 81, "006": [82, 84, 86], "0060": 85, "0065": [40, 81, 84], "0067": 81, "007": [73, 88], "0070": 85, "0071": 81, "0072": 74, "0075": 81, "0076": 82, "0077": 82, "0078": 82, "007852057721998333": 3, "008": [84, 88], "008012": 75, "0082": 74, "0089": 82, "009": 82, "0090": 82, "0091": [78, 82, 85], "009233084500921031": 3, "0093": 85, "0094": 85, "00945189": [], "00945197": 86, "0097": 86, "0098": 86, "009998": 81, "00h": 79, "01": [22, 35, 40, 54, 73, 74, 75, 76, 77, 79, 81, 82, 84, 85, 86, 95, 96], "010": [84, 88], "0101": 74, "0102340": 82, "01025": 81, "01035": 81, "0107": 85, "0108": 82, "0109": [81, 82], "01092": 81, "011": [73, 82, 84, 86], "01104": 81, "0111": 85, "01122": 86, "0114": 86, "0115": 85, "0117": [74, 82, 85], "0118": 85, "011931": 86, "0119311": [], "012": [79, 84, 85, 86, 88], "013": [82, 84, 85, 86, 87], "0131": 85, "0134": 86, "01357": 86, "0137": 74, "0139": 86, "014": 84, "0140": 86, "0144": 86, "0145": 86, "015": [74, 79, 84, 86, 87], "0150": 85, "0151": 86, "0152": 81, "015245": 81, "015246": 81, "015251": 81, "015256": 81, "015267": 81, "015269": 81, "015287": 81, "0153": 82, "01535": 81, "015395": 81, "0154": 82, "0155": [82, 86], "0156": [81, 82], "015875": 81, "016": [82, 84, 86], "0163": 86, "016585": 85, "016592": 85, "016653": 85, "016897": 85, "017": [73, 82, 84], "0171": 85, "0172": 85, "0173": 81, "017411": 85, "018": [76, 84], "0180": 86, "0181": [82, 85], "018138": 75, "018187": 85, "0182": [82, 85], "0185": 85, "0187": 82, "0188": [82, 86], "0189": 86, "019": [76, 82, 84, 86, 87], "0190": 86, "0192": 86, "019202": 81, "0193": 82, "0194": [74, 82], "0195": 82, "019552": 81, "019553": 81, "019579": 81, "01966": 81, "0198": 86, "019867": 81, "02": [1, 14, 40, 41, 51, 53, 54, 58, 59, 60, 74, 76, 79, 81, 82, 84, 85, 86, 95, 96], "020": [73, 76, 79, 82, 84, 86], "02000": [82, 86], "0202": 86, "0203": 86, "0209": 74, "021": [76, 78, 82, 84, 85], "02159": 81, "021919": 81, "021931": 81, "022": [81, 82, 84], "02202": 81, "02204": 81, "022041": 81, "0221": 85, "02218": 88, "0222": 88, "0224": 82, "0225": 82, "02263": 81, "0227": 86, "022913": 81, "02297": 83, "023": [73, 76, 82, 84, 88], "0231": 82, "02339": 81, "0237": 78, "024": [84, 88], "0244": 74, "0246": 86, "0247": 86, "0248": 86, "0249": 86, "025": [76, 82, 84, 86, 88], "0250": 78, "02501": 73, "0251": 74, "0252": 82, "02585": 83, "02594": 83, "026": [76, 84, 86, 87], "027": [78, 82, 84, 86], "0275": 83, "02791": 81, "027998": 81, "028": [73, 76, 78, 82, 84, 85], "0280": 88, "028146": 81, "02846": 81, "0286": [], "0289": 83, "029": [11, 53, 79, 82, 84, 88], "0293": [83, 88], "02939": 86, "02982": 86, "02988": 81, "02996": 86, "02997": 81, "02d": [76, 83], "03": [38, 40, 73, 76, 79, 81, 82, 84, 85, 86, 95, 96], "030": [82, 84, 85, 87, 88], "03001": 86, "03019": 86, "03025": 86, "03034": 86, "03065": 86, "03096": 86, "031": [78, 82, 84, 85, 86], "03118": 86, "03122": 86, "03123": 86, "03127": 86, "03149": 86, "03157": 86, "03158": 86, "032": [73, 79, 82, 84, 86, 88], "0320": 81, "03204": 86, "03208": 86, "03209": 86, "0321": 74, "0322": 86, "03243": 86, "0326": 86, "03272": 86, "03288": 86, "03293": [], "03294": 86, "03295": 86, "033": [73, 76, 78, 82, 84, 87], "03302": 86, "03338": 86, "03376": 81, "03379": 86, "03395": 86, "03396": [], "034": [73, 79, 84], "03409": 86, "03422": 86, "03425": 86, "03433": 86, "0344": 75, "0345": 86, "034575": 81, "03468": 81, "0347": 86, "03481": 81, "03482": 86, "03485": 86, "03495": 86, "03496": [], "035": [79, 84, 85, 86, 87], "03501": 86, "03515": 86, "03518": 81, "03532": 86, "0356": 81, "03563": 86, "03577": 81, "03583": 86, "03588": 81, "036": [84, 85, 86], "03613": 82, "03614": 82, "03646": 86, "03656": 81, "03677": 82, "03682": 81, "037": [82, 84, 85, 86, 87], "03702": 82, "03707": 86, "03718": 82, "0372": 86, "0373": 82, "03742": 86, "0375": 86, "03772": 82, "038": [76, 85, 96], "03842": 82, "038826": 81, "03884": 86, "039": [76, 82, 84, 85, 86], "039473": [], "039474": [], "039475": [82, 86], "039476": 86, "039479": [], "03948": 86, "039488": [], "039489": 86, "03953": 82, "039693": [], "039695": 86, "03982": 82, "03984": 82, "03988": 82, "04": [40, 44, 73, 74, 76, 78, 79, 81, 82, 84, 85, 86, 88, 95, 96], "040": [78, 84, 86, 87], "04029": 83, "040455": 81, "040469": 86, "040471": 86, "040475": 86, "040476": [], "04049": 82, "040498": 86, "040613": 86, "040659": [], "040661": 86, "040762": 81, "0409": 84, "041": [73, 76, 81, 84, 86], "04112": 81, "041158": 86, "04119": 82, "0412": 84, "04124": 82, "04128": 81, "0413": 82, "04132": 82, "04138": 81, "0414": 84, "041514": 81, "0416": 86, "0417": 84, "04171": 82, "04174": 81, "04178": 81, "0418": 84, "04183": [82, 86], "042": [76, 84, 85], "0421": 82, "04222": 81, "042236": 85, "0424": 81, "042413": 85, "042452": 85, "04251": 81, "042591": 85, "04261": 81, "042631": 85, "042632": 85, "042657": 81, "04269": 82, "0427": 85, "0429": 85, "043": [78, 79, 82, 84, 86], "043153": [], "043154": 86, "043495": 81, "0438": 84, "0439": 84, "044": [73, 84], "0441": [82, 84], "044181": 86, "0442": 84, "04424": 82, "0443": 84, "04434": 82, "04435": 82, "0444": 84, "0445": 82, "04459": 82, "04466": [81, 82], "044662": 81, "044668": 81, "04467": 82, "04468": 81, "044695": 81, "044708": 81, "044746": 81, "04477": 82, "04478": 82, "0448": 84, "044868": 81, "045": [73, 76, 84, 85], "045054": 81, "04519": 82, "045205": 81, "045228": 81, "04524": [81, 82], "04528": 82, "0453": 85, "04538": [81, 82], "0455": 86, "045568": 81, "04558": 86, "0457": 86, "045937": 81, "046": [73, 76, 84, 85, 86], "04602": 86, "04604": 82, "046104": 85, "046255": [86, 87], "046257": [], "046259": [86, 87], "046261": [], "046263": [86, 87], "046264": [], "046274": [86, 87], "046276": [], "046337": [86, 87], "046338": [], "04634": 81, "04642": 82, "0467": 84, "04673": 82, "04679": 82, "0468": 83, "04686": 82, "046957": 86, "04698": 86, "046981": 86, "046993": 86, "046997": 86, "047": [73, 74, 76, 84, 86], "047719": 81, "047721": 81, "047726": 81, "047736": 81, "047738": 81, "047759": 81, "047833": 81, "047836": [], "047837": 86, "047924": [86, 87], "047928": [86, 87], "04794": 82, "047941": [86, 87], "047964": [86, 87], "048": [76, 84], "048039": [86, 87], "0481": 75, "048167": 81, "04847": 86, "048472": 86, "048479": 86, "048491": 86, "0485": 86, "048503": 86, "048515": 86, "04852": 86, "048528": 86, "048535": 86, "048536": 86, "048537": 86, "04854": 86, "04859": 86, "048681": 86, "048684": 86, "048696": 86, "048722": 86, "048834": 86, "049": [84, 85, 86, 87], "049034": 81, "04913": 82, "049152": 86, "049153": 86, "049155": 86, "049156": 86, "049172": 86, "0492": 82, "049219": 82, "049287": 82, "049393": 82, "0494": 86, "049473": 86, "049474": 86, "049483": 86, "049494": 86, "049495": 86, "049498": 86, "049499": 86, "049507": 82, "049518": 86, "0496": 83, "049663": 82, "0497": 85, "04974": 82, "049808": 81, "05": [11, 14, 21, 40, 41, 51, 53, 54, 58, 69, 72, 74, 75, 76, 81, 82, 83, 84, 85, 86, 88, 96], "050": [73, 76, 82, 84, 86, 87], "050076": 81, "05018": 82, "050231": 82, "05039": 82, "05068": 82, "050729": 81, "05077": 82, "05087": 82, "050901": [86, 87], "050906": [86, 87], "05097": 82, "051": [73, 75, 76, 82, 84, 85], "051014": 81, "05102": 82, "051066": [86, 87], "0511": 82, "05114": 82, "051142": 81, "051408": 81, "051594": 82, "052": [73, 76, 82, 84, 85, 86], "052336": [86, 87], "052372": [86, 87], "052378": [86, 87], "052619": 81, "052654": 81, "05266": 82, "05293": 82, "053": [73, 84, 85, 87], "05329": 82, "05334": 82, "05341": 82, "053549": 82, "05362": 82, "05369": 82, "05383": 84, "05389": 84, "05395": 84, "054": [73, 76, 84, 86], "05406": 84, "05422": 84, "05445": 82, "0546": 88, "055": [74, 76, 84, 85, 86], "05535": 84, "05536": 84, "05538": 81, "055477": 82, "055785": [86, 87], "056": [76, 84, 85, 86], "0561": 88, "05629": 82, "05684": 84, "056976": 81, "057": [78, 84], "05703": 84, "05713": 82, "05721": 84, "05753": 82, "057678": 82, "057682": 82, "057685": 82, "057687": 82, "057688": 82, "057702": 82, "057786": 81, "057788": 82, "057789": 86, "057829": 81, "05791": 81, "058": [3, 73, 82, 84], "058023": 81, "058114": 81, "058126": 82, "058127": 81, "058167": 81, "058198": 81, "058208": 81, "05821": 81, "058323": 82, "05853": 84, "058974": 82, "059": [73, 82, 84, 85, 86, 87], "059567": [86, 87], "05968": 82, "0598562": 86, "05ch11231": [0, 90], "06": [18, 23, 24, 25, 40, 48, 63, 73, 74, 76, 81, 82, 83, 84, 85, 86], "060": [76, 79, 84], "06016": 86, "06024": 86, "06032": 86, "060443": 82, "060489": 81, "06057": 84, "06074": 84, "061": [76, 82, 84, 85, 86], "061756": 81, "062": [73, 79, 82, 84, 86], "06229": 81, "062547": 82, "0626": [83, 86], "06294": 86, "063": [76, 81, 82, 85, 86, 87, 88], "063075": 81, "063395": 81, "063401": 81, "063419": 81, "063456": 81, "06351": 81, "063529": 81, "063617": 81, "063629": 81, "063644": 81, "063645": 81, "063654": 81, "063682": 81, "063706": 81, "063734": 81, "06379": 81, "0638": 86, "063825": 81, "063827": 81, "0639": 86, "063949": 81, "064": [76, 84, 85], "064045": 81, "064091": 81, "06414": 81, "06416": 81, "06454": 81, "06467": 81, "06472": 84, "06499": 85, "065": [84, 86], "06501": 84, "06504": 82, "065253": 85, "065257": 85, "06528": 84, "065282": 85, "06533": 84, "065412": 85, "0656": 82, "065727": 85, "06574": 81, "066": [84, 85, 86], "066176": 85, "066238": 81, "06627": 81, "066282": 82, "06694": 86, "067": [73, 76, 84, 86, 88], "067273": 81, "0673": 83, "067369": 81, "067371": 81, "067439": 81, "067531": 81, "067587": 81, "067607": 81, "067617": 81, "06762": 81, "068": [73, 82, 84, 85, 87], "0684": 78, "068866": 81, "069": [76, 84, 85], "06931": 81, "069418": 82, "069424": 82, "069463": 82, "069491": 81, "069573": 82, "069583": 82, "069746": 82, "069797": 82, "069841": 82, "069855": 82, "06e": 84, "06m": 79, "07": [48, 74, 75, 76, 77, 81, 82, 83, 84, 86], "070": [79, 86], "071": [73, 76, 77, 82, 84, 85, 86], "07167": 81, "072": [73, 76, 84, 85, 86], "0721": 86, "073": [73, 76, 84, 86], "073655": 81, "074": [73, 76, 84, 85], "074814": 81, "075": [73, 76, 79, 84, 85], "075038": 81, "0754": 81, "075491": 82, "075799": 82, "0758": [82, 86], "075811": 82, "075866": 82, "0759": 86, "075965": 82, "076": [73, 75, 76, 82, 84, 85, 88], "07608": 82, "0761": 86, "076245": 82, "076246": 82, "076252": 82, "076266": 82, "076268": 82, "076281": 82, "076289": 82, "076296": 82, "076313": 82, "076338": 82, "076361": 82, "076424": 82, "076534": 81, "0766": 82, "076606": 82, "076641": 82, "076743": 82, "0768": 83, "0769": 88, "076915": 82, "077": [73, 76, 79, 84, 85, 96], "0772": [82, 86], "0774": 83, "0775510135829585": 76, "077690418635804": 3, "0777": 88, "078": [73, 76, 78, 79, 85, 86], "0781": [], "0783": 86, "078347": 82, "078348": 82, "078361": 82, "078446": 82, "07875": 82, "079": [73, 76, 84, 85], "079354": 82, "07953": 86, "079758": 85, "07ghz": [81, 83], "08": [73, 76, 81, 82, 84, 85, 86], "080": [73, 74, 76, 82, 84, 85], "08015": 82, "080441": 81, "08055": 86, "08057": 86, "08067": 86, "08069": 86, "080697": 81, "080738": 82, "08096": 86, "081": [76, 82, 84, 85, 86], "081075": 82, "081138": 82, "08118": 86, "081227": 82, "08125": 82, "081288": 82, "081303": 82, "081305": 82, "081315": 82, "081329": 82, "08134": 82, "081346": 82, "08135": 86, "081356": 82, "081358": 82, "081373": 82, "0814": 86, "081403": 82, "081412": 82, "08143": 86, "081442": 82, "081466": 82, "081471": 82, "08148": 86, "081515": 82, "081591": 82, "081722": 81, "081958": 81, "082": [73, 74, 76, 84, 85], "082035": 82, "082036": 82, "08205": 86, "08213": 86, "082152": 82, "08228": 82, "082315": 82, "082318": 82, "08254": 86, "08264": 86, "082715": 81, "08282": 86, "082836": 81, "08285": 86, "08299": 86, "083": [76, 82, 84], "08308": 82, "0832": 88, "083417": 82, "083513": 81, "08362": 86, "083698": 74, "0838": 85, "0839": [85, 86], "084": [76, 82, 84, 86], "08422": 86, "08427": 86, "08438": 86, "084417": 81, "08443": 86, "0847": 83, "084967": 81, "084969": 81, "08498": 81, "085": [73, 76, 84, 85], "085025": 81, "085115": 81, "085215": 81, "085247": 81, "085285": 81, "085337": 81, "085391": 81, "085475": 81, "085597": 81, "0856": 83, "085719": 81, "085801": 81, "085882": 81, "085887": 81, "085909": 81, "085958": 81, "086": [76, 84, 86], "086026": 81, "086068": 81, "08608": 81, "086115": 81, "086122": 81, "086136": 81, "086155": 81, "086176": 81, "086181": 81, "086195": 81, "086197": 81, "08649": 86, "08685": 86, "086918": 81, "087": [76, 82, 84], "088": [76, 84, 85, 86], "088252": 81, "089": [73, 76, 85], "09": [73, 74, 76, 78, 79, 81, 82, 84, 85, 86, 95], "090": [73, 76, 85, 86], "090391": 81, "091": [73, 78, 84, 85, 87], "0913": 88, "091952": 81, "092": 76, "092076": 81, "092555": 81, "093": [82, 84, 85], "093342": 81, "0934": 83, "093519": 81, "094": [76, 82, 84], "094318": 81, "094714": 81, "095": [76, 85, 86, 88], "09509": 81, "095596": 82, "095601": 82, "095677": 82, "096": [73, 84, 86], "096297": 82, "096504": 82, "096506": 82, "096656": 82, "096919": 81, "097": [76, 84, 85], "097393": 81, "09768": 82, "09771": 82, "097735": 81, "097838": 82, "098": 86, "098106": 82, "098364": 81, "09844": 82, "098888": 81, "098988": 81, "099": [73, 86, 88], "099929": 81, "1": [0, 1, 2, 3, 4, 6, 11, 14, 16, 17, 18, 21, 22, 29, 33, 34, 35, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 57, 59, 60, 62, 63, 64, 66, 68, 69, 70, 72, 73, 74, 76, 77, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96, 99], "10": [1, 11, 14, 15, 40, 41, 42, 43, 47, 51, 53, 54, 55, 56, 58, 59, 60, 63, 72, 73, 74, 75, 78, 79, 81, 82, 83, 84, 85, 86, 88, 95, 96], "100": [1, 18, 40, 41, 45, 47, 50, 51, 53, 54, 55, 58, 59, 60, 63, 72, 73, 76, 79, 81, 82, 84, 85, 86, 87, 88], "1000": [38, 47, 53, 54, 59, 60, 73, 82, 83, 85, 86], "10000": [64, 78], "1000000": [14, 23, 53, 59, 60], "10000000": 14, "10007": 82, "10009": 81, "1001": 82, "1003": [73, 82], "1005": 82, "1006": 82, "10087": 81, "1009": [73, 82], "100um": 63, "101": [73, 77, 82, 84, 86], "1010": 82, "1011": [81, 82], "101111": 86, "1012": 82, "101265": 86, "1013": [73, 82], "1014": 82, "101460": 86, "10162": 81, "10167": 81, "1017": [73, 82], "10172": 85, "10179": 81, "101813": 86, "10189": 84, "101e": [], "102": [73, 82, 84, 85, 86], "1020": 82, "102009": 86, "10213": 86, "10214": 86, "10215": 86, "10216": [], "10219": 81, "1022": [73, 82], "10220": 84, "10221": [81, 84], "10226": 86, "1024": 73, "10244": 81, "10246": 86, "10247": [], "1025": 82, "10252": 82, "1026": [73, 82], "1028": [84, 86], "1029": 84, "103": [40, 73, 82, 84, 85, 86], "1030": 82, "1031": [73, 86], "10312": 84, "1032": 82, "10324": 81, "1033": 83, "1034": [73, 82], "10341": 86, "10344": 84, "1035": 82, "1036": [11, 73, 82], "10363": 81, "1037": 82, "1038": [79, 82], "1039": 82, "10398": 81, "104": [73, 74, 75, 82, 84, 85, 86, 87], "1040": [11, 76], "10408": [81, 82], "1041": [82, 85], "10412": 84, "10416": 84, "1042": [82, 83], "1043": 82, "10448": 85, "1045": 82, "1046": [82, 83], "10463": [86, 87], "10467": [86, 87], "10469": 86, "1047": [81, 82, 83], "10472": [86, 87], "10473": [], "10474": [86, 87], "10475": [86, 87], "1048": 83, "10485670": [53, 59, 60], "1049": 83, "105": [73, 82, 84, 85, 86], "10505": [86, 87], "1051": 82, "10514": [86, 87], "1052": [83, 86], "10522": 86, "10525": 86, "10531": 86, "105342": 86, "1054": 76, "1056": 82, "1057": 82, "105712": 86, "105724": 86, "1058": 82, "1059": 73, "106": [74, 81, 82, 84, 86], "1060": [82, 83], "1061": [76, 82], "10617": 82, "10619": 82, "1062": [40, 84], "1063": [76, 82], "10635": 82, "10638": 86, "10639": 86, "1064": 86, "10641": 86, "10648": [86, 87], "1065": [76, 82], "1067": [82, 86], "106715": 86, "10673": 86, "10676": 86, "10677": 86, "10679": 82, "1068": [82, 88], "10686": 86, "10688": 86, "106889": 86, "106891": 86, "1069": 82, "10693": 86, "107": [73, 74, 82, 84, 86], "1070": 83, "10702": 82, "107089": 86, "107097": 86, "1071": 82, "1072": 73, "107264": [86, 87], "107277": 86, "1073": 82, "10730": 82, "1074": 82, "10746": 81, "10754": 85, "1076": [82, 86], "1078": 82, "1079": 82, "107999": 86, "108": [82, 84, 85, 86, 88], "1080": [53, 59, 60], "1081": [73, 81], "1082": 82, "108207": 86, "1083": [82, 83], "10841": 82, "1086": [82, 83], "10869": 83, "1087": 82, "10877": 83, "10878": 81, "10879": 83, "108857": 86, "10888": [86, 87], "10889": 83, "1089": 82, "109": [73, 81, 82, 84, 85, 86, 95], "1090": 82, "1091": [], "1092": 82, "1093": 81, "1094": [82, 83, 86], "1095": 82, "10956": 82, "1096": [81, 82], "10965": 81, "1097": [82, 83], "1099": 82, "11": [40, 73, 74, 76, 78, 81, 82, 83, 84, 85, 86, 87, 88, 95], "110": [73, 82, 84, 86], "1100": [81, 86], "1101": [73, 82], "1103": 82, "11037": 81, "1104": [76, 81, 82, 85], "1105": 83, "1106": 82, "1107": [11, 47, 53, 59, 60, 75], "11078": 81, "1108": 84, "1109": 82, "11094": 86, "111": [73, 74, 76, 81, 82, 84, 86, 95], "1110": [82, 84], "11116": 81, "1112": 73, "1112402970091422": 76, "11128": 81, "1114": 73, "11146": 81, "1115": 73, "1116": 82, "1119": [], "112": [81, 82, 85, 86], "1120": [40, 82, 84, 86], "11202": 85, "11206": [], "11207": 86, "1121": [73, 82, 86], "1122": 82, "1123": 82, "11241": 82, "1125": 81, "1126": 82, "112674": 86, "1127": [40, 84], "1128": [81, 84], "1129": [82, 84], "113": [74, 76, 81, 82, 86], "1130": [82, 83, 86], "1131": [81, 82], "1132": 82, "1133": 85, "11336": 81, "11345": 81, "1135": 86, "113599": 86, "113621": 86, "113637": 86, "11368": 81, "1137": 82, "113784": 86, "113803": 86, "113865": 86, "113880": 86, "113906": 86, "11391": 81, "113913": 86, "113958": 86, "113990": 86, "114": [73, 82, 84, 85, 86], "1140": 82, "114013": 86, "114017": 86, "114024": 86, "114060": 86, "114065": 86, "1141": 82, "114109": 86, "114110": 86, "114113": 86, "114123": 86, "114124": 86, "114137": 86, "114140": 86, "114144": 86, "114150": 86, "114151": 86, "114154": 86, "114178": 86, "114191": 86, "114199": 86, "1142": 83, "114207": 86, "114214": 86, "114230": 86, "11424": 82, "114242": 86, "114243": 86, "114265": 86, "114266": 86, "114275": 86, "114277": 86, "114292": 86, "114325": 86, "114431": 86, "114470": 86, "114482": 86, "1145": 82, "114507": 86, "114518": 86, "114543": 86, "114555": 86, "11457": 86, "11465": 84, "1147": 84, "1148": [81, 84], "114816": 86, "11484": 84, "1149": 76, "115": [74, 82, 86, 88], "1150": 82, "1152": 83, "1154": 82, "1155": 86, "1156": 82, "11564": 81, "116": [73, 78, 82, 86], "1161": 82, "11626": 83, "1165": 82, "1166": 82, "1167": [82, 86], "1168": 86, "117": [74, 82, 84, 85, 86], "1171": [84, 86], "11716": 81, "1172": [82, 83], "1173": 82, "1174": [81, 84], "1175": [81, 82], "1176": 81, "1177": 86, "11775": 81, "1178": [81, 82], "11794": 87, "118": [74, 78, 82, 86], "1180": 82, "1181": 86, "1182": 82, "11826": 81, "1183": [84, 86], "11833": 86, "11836": 81, "1184": 84, "11840": 84, "1185": 82, "11851": 81, "1186": [82, 86], "1187": 86, "1188": 82, "1189": [81, 82, 84, 86], "11892": 84, "119": [78, 81, 82, 84, 86, 96], "1190": [83, 85], "11907": 81, "1191": [82, 84, 86], "11915": 81, "11927": 84, "1193": [82, 84], "1194": 82, "11943": 82, "1195": 82, "1197": [84, 86], "11972": 81, "11975": 81, "1198": [82, 86], "1199": 82, "12": [11, 40, 73, 74, 76, 78, 81, 82, 83, 84, 85, 86, 88], "120": [0, 1, 45, 46, 47, 50, 51, 78, 82, 84, 86, 87, 96], "1200": [83, 84], "1201": 86, "120152": 79, "1202": 82, "12029": 81, "1203": [76, 82], "1204": [82, 86], "1205": [83, 86], "1207": [82, 84], "1208": [82, 84, 86], "1209": [82, 84, 86], "121": [11, 73, 76, 77, 78, 82, 84, 86], "1210": [81, 83, 86], "1211": 83, "1212": [76, 84], "12121": 81, "1213": 84, "1214": [82, 86], "12145": 81, "121474": 82, "12164": 81, "12167": 81, "1217": [82, 85, 86], "1219": [82, 86], "12198": 88, "122": [73, 76, 78, 82, 84, 86], "1220": [76, 86], "1221": [76, 82, 84, 86], "1222": [81, 82, 86], "1223": [82, 86], "12234": 81, "1224": 84, "12248": 82, "1225": [82, 84], "1226": [82, 84, 86], "1227": [82, 84], "1228": 86, "12280": 82, "12281": 82, "1229": [84, 86], "12291": 81, "123": [40, 73, 78, 82, 84, 86], "1230": [84, 88], "1231": [82, 84, 86], "12311": 84, "1232": [81, 83], "12326": 84, "1233": [82, 84, 86], "1234": [49, 86], "1235": 86, "1236": 82, "12373": 84, "1238": [82, 86], "12386": 84, "124": [73, 74, 76, 78, 82, 84, 85, 86], "1240": [82, 86], "1241": 82, "1242": [82, 86], "1243": [81, 82], "12431": 81, "1245": 86, "1248": [82, 86], "12494": 81, "124946": 86, "12495": 81, "125": [0, 73, 76, 78, 81, 82, 84, 85, 86], "1252": [82, 86], "12524": 84, "12527": 84, "12528": 81, "1253": [82, 86], "1254": 82, "12543": 81, "12546": 84, "1255": [82, 86], "1256": [82, 84, 86], "12568": 86, "1257": [82, 86], "1258": [82, 84, 86], "12582": 81, "1259": [82, 86], "126": [0, 2, 73, 78, 82, 84, 86], "1261": [83, 86], "12612": 81, "12619": 82, "1262": 86, "1263": [82, 86], "1264": [82, 86], "12647": 81, "1265": 86, "1266": 82, "1267": 86, "1268": [82, 86], "1269": [84, 86], "12695": 85, "127": [73, 76, 78, 81, 82, 84, 86], "1270": 86, "1271": [84, 86], "1273": [82, 86], "12735": 81, "1274": 95, "1275": [86, 88], "1276": [82, 86], "12769": 95, "1277": [84, 86], "12774": 81, "1278": [76, 82, 86], "128": [73, 76, 78, 81, 82, 84, 86], "1281": [82, 86], "12815": 81, "1282": 86, "1283": 82, "12831": [], "12834": 86, "1284": [40, 82, 84, 86], "12845": 81, "1285": [82, 86], "1286": [81, 82, 86], "128604": 86, "1287": [82, 86], "1288": [82, 86, 88], "1289": 86, "129": [73, 76, 78, 82, 84, 86], "1290": 86, "12908": 86, "1291": [82, 86], "12917": 84, "1292": [82, 86], "1293": [85, 86], "12934": 81, "1294": 86, "12942": 81, "1295": 86, "1296": [82, 86], "1297": [82, 83, 86], "12970": 86, "1298": [82, 86], "12987": 82, "129876": 82, "1299": [81, 86], "12th": 99, "13": [40, 73, 74, 76, 77, 81, 82, 83, 84, 85, 86, 96], "130": [76, 78, 82, 86], "1300": [82, 86], "13001": 81, "1301": 82, "13032": 82, "1304": 86, "1305": 82, "1306": 86, "1307": [82, 86], "130748": 82, "130749": 82, "1308": [82, 83], "130878": 82, "1309": [82, 86], "130920": 82, "130947": 82, "130961": 82, "130988": 82, "131": [76, 78, 81, 82, 86], "1310": 86, "131032": 82, "131069": 82, "131072": 82, "131075": 82, "1311": 86, "131102": 82, "131107": 82, "131138": 82, "131143": 82, "131181": 82, "1312": 86, "131244": 82, "131286": 82, "131302": 82, "131333": 82, "131360": 82, "131363": 82, "131398": 82, "131446": 82, "13145": 76, "131474": 82, "131478": 82, "1315": 86, "131503": 82, "131505": 82, "131546": 82, "131547": 82, "131553": 82, "131574": 82, "1316": 82, "131615": 82, "131653": 82, "131689": 82, "131699": 82, "1317": 86, "131706": 82, "131708": 82, "131729": 82, "131757": 82, "131784": 82, "1318": 86, "131818": 82, "131849": 82, "1319": 86, "131909": 82, "131936": 82, "131949": 82, "13198": [86, 87], "132": [0, 76, 78, 81, 82, 84, 85, 86], "1320": 86, "132001": 82, "132052": 82, "1321": [82, 86], "1322": 86, "1323": [82, 86], "1324": 86, "1325": [82, 86], "13252": 83, "13254": 83, "13258": 83, "1326": [83, 86], "13260": 84, "13265": 83, "1327": [82, 86], "13279": 82, "1328": [82, 86], "13282": [83, 88], "13283": 84, "13299": 82, "133": [81, 82, 84, 86], "1331": [83, 86], "1332": [82, 86], "1333": 86, "1334": [82, 83], "13349": 82, "1335": [82, 86], "13354": 84, "1336": [82, 83], "1337": [82, 86], "13375": 81, "1338": [82, 86], "1339": [82, 86], "13392": 84, "134": [76, 78, 81, 82, 84, 85, 86], "1340": [82, 86], "1341": 86, "13413": [86, 87], "1342": 82, "1343": [82, 86], "134383": 74, "1344": [82, 86], "1345": [82, 86], "13459": 81, "1346": 86, "1347": [82, 86], "13476": [86, 87], "1348": 86, "1349": 86, "135": [76, 81, 82, 86], "1350": [82, 86], "1351": [82, 86], "1352": 86, "1353": 86, "13534": 83, "1354": [82, 86], "1355": 86, "13559": 81, "1356": 86, "1357": 86, "1358": [83, 86], "13596": 84, "136": [0, 2, 73, 78, 82, 84, 85, 86, 96], "1360": 82, "1360324992": 3, "1360324993": 3, "1360324994": 3, "1361": [73, 81, 82], "1362": [82, 86], "1363": [81, 86], "1364": [83, 86], "1365": 82, "1366": [82, 86], "1367": 86, "1368": 86, "1369": 86, "137": [73, 74, 82, 84, 85, 86, 88], "1371": 86, "1372": 82, "13728": 81, "1373": [73, 86], "13737": 81, "1374": 86, "1375": 86, "13758": 84, "1376": 86, "1377": 83, "1379": [82, 86], "138": [82, 85, 86], "1380": [84, 86], "13802": 84, "1381": [82, 83, 86], "13814": 86, "1382": 86, "1383": [82, 86], "13833": 85, "1384": [82, 86], "1385": [82, 86], "1387": 82, "1388": 86, "13887": 81, "1389": [82, 86], "139": [76, 82, 85, 86], "1390": 86, "1391": [82, 86], "1392": 82, "1393": [82, 86], "13937": 84, "1394": 86, "1396": 81, "1397": [81, 86], "1398": 86, "1399": [82, 83, 86], "13_integr": 79, "13th": 99, "14": [3, 40, 73, 74, 76, 81, 82, 83, 84, 86, 95], "140": [73, 76, 81, 82, 84, 86], "1400": 95, "1401": 82, "1403": 86, "1404": [40, 82, 84, 86], "1405": 86, "1406": 86, "1407": [82, 84, 86], "14071": 76, "1408": [82, 84, 86], "1409": 86, "141": [76, 82, 84, 85, 86], "1410": [82, 86], "14108": 81, "1411": [82, 86], "1412": 82, "14121": 84, "14122e": 82, "1413": [83, 86], "1414": [82, 86], "1415": 86, "1416": 86, "14168": 81, "1417": [82, 86], "1418": [82, 86], "1419": [82, 86], "142": [73, 76, 82, 84, 86], "1420": [82, 86], "1421": [82, 86], "1422": [82, 83], "1423": 86, "1424": [82, 86], "1425": [82, 86], "1426": 86, "1427": [82, 86], "1428": [73, 82], "1429": [82, 83, 86], "143": [82, 84, 86], "1430": [82, 83, 86], "14306": 81, "1431": 86, "1432": [82, 86], "1433": [82, 86], "14334": 86, "14339": 81, "1434": 86, "1435": [82, 86], "1436": [82, 84, 86], "1437": 86, "14379": 81, "1438": [83, 86], "1439": 86, "14397": 84, "144": [74, 76, 82, 86], "1440": [82, 86], "1441": 86, "1442": 86, "1444": 86, "1445": [82, 86], "1447": [82, 86], "14476": 81, "1448": 86, "1449": 82, "145": [0, 73, 76, 81, 82, 84, 86], "1451": 82, "14510": 82, "1452": [82, 86], "1453": 86, "1454": [82, 83, 86], "1455": 86, "1456": 86, "1457": 86, "1458": [82, 86], "1459": [86, 95], "146": [73, 81, 82, 84, 86], "1460": 86, "1461": 86, "14610": 82, "14619": 82, "1462": [82, 83, 86], "1463": [82, 86], "1464": [82, 83, 86], "1465": [86, 95], "14653": 81, "1466": 86, "1467": [83, 86], "14673": 81, "14677": 84, "14678": 84, "14689": 81, "1469": 86, "147": [73, 82, 86], "1470": [82, 86], "1471": [83, 86], "1472": [83, 86], "1473": [82, 83, 86], "1474": [81, 82, 86], "1475": 86, "14752": 85, "1476": [82, 86], "14767": [], "14768": 86, "1477": [82, 83, 86], "1478": [81, 86], "14785": 81, "1479": 82, "148": [73, 76, 81, 82, 84, 86], "1480": 86, "14804": 86, "1481": 83, "1482": 86, "1484": 86, "14842": 81, "1485": 86, "1486": 82, "1487": 82, "148799": [40, 84], "1488": [82, 86], "1489": [82, 86], "149": [73, 76, 79, 82, 84, 86], "1490": [78, 86], "1491": [82, 86], "1492": 86, "14920": 82, "1493": [82, 86], "1495": 82, "1496": 82, "1497": 86, "1498": [78, 86], "1499": 86, "15": [14, 40, 53, 54, 63, 73, 76, 81, 82, 83, 84, 85, 86], "150": [47, 53, 54, 63, 69, 72, 73, 79, 81, 82, 84, 85, 86, 87], "1500": [82, 86], "15001": 81, "15006": 81, "1501": 86, "1502": 86, "1503": [82, 86], "15033": 81, "15038": 81, "1504": 86, "1505": [82, 86], "1506": [85, 86], "15064": 87, "15067": 82, "1507": [81, 82, 86], "15071": 82, "1508": [78, 83, 86], "1509": [82, 86], "151": [73, 76, 81, 82, 84, 85, 86], "1510": 86, "1511": [81, 86], "1512": [81, 82, 86], "151254": 86, "1513": 86, "1514": 82, "15140": 76, "15145": 82, "1515": 86, "15151": 81, "15165": 85, "1518": 86, "1519": 86, "151986": [], "151988": 86, "152": [78, 81, 82, 84, 86], "1520": 86, "1521": 86, "1522": 82, "1523": 86, "1524": 82, "1526": 86, "1527": 82, "1528": 86, "15287": 82, "1529": [83, 86], "15295": 81, "153": [76, 78, 81, 82, 84, 86], "1530": [82, 86], "1531": 86, "1532": 86, "15320": 76, "15323": 81, "1533": [82, 86], "1534": [82, 86], "1535": [78, 86], "1536": [82, 86], "15365": 81, "1537": 86, "15371": 86, "15376": 83, "1538": [85, 86], "1539": 85, "15398": 82, "154": [74, 76, 78, 81, 82, 85, 86], "1540": 86, "15417": 81, "1542": 86, "15427": 81, "1544": 82, "1545": 86, "1546": 86, "15463": 81, "1547": 81, "1549": 86, "155": [73, 76, 81, 82, 84, 86], "1550": [81, 86], "1551": [83, 86], "1552": 86, "1553": 86, "15548": 82, "1555": [82, 86], "15575": [86, 87], "1558": 86, "15582": 85, "15589": 81, "1559": 86, "155e": 82, "156": [76, 82, 84, 86], "1560": [78, 86], "1561": 82, "1562": [78, 82, 86], "156241": [], "156242": 86, "1563": [82, 83, 86], "1564": 86, "15652": 82, "1566": 86, "1568": 86, "1569": [83, 86], "157": [3, 76, 82, 84, 86], "1570": [83, 86], "15719": 82, "1572": 86, "1573": [78, 86], "1574": 86, "1575": 86, "1576": [82, 86], "1576060": 78, "1577": 86, "15776": [81, 82], "1578": 82, "1579": 86, "15798": 73, "158": [73, 76, 81, 82, 84, 86], "1580": 86, "1581": [83, 86], "15812": 82, "1582": 86, "15826": 82, "1583": [86, 88], "1584": [78, 86], "158400": 76, "15842": 82, "1585": 86, "1586": [82, 86], "1587": [83, 86], "1588": [83, 86], "1589": [81, 86], "159": [78, 82, 83, 84, 86], "1590": 82, "1591": 86, "1592": 82, "1593": 86, "1594": 86, "1596": 86, "1597": 86, "15973": 73, "1598": [82, 86], "1599": 86, "16": [3, 40, 48, 73, 74, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 95], "160": [73, 82, 84, 85, 86], "16001": 82, "1601": 86, "16016": 81, "16023": 82, "1603": 86, "1605": 86, "16051": 82, "1606": 86, "1608": 86, "1609": 86, "161": [73, 76, 82, 84, 86], "1610": 86, "1611": 82, "1612": 86, "16125": 81, "1613": 86, "16130": 81, "1614": 86, "16140": 82, "1615": [75, 86], "1616": 82, "1617": 86, "1618": 86, "16185": 81, "1619": [73, 86], "16199": 83, "162": [78, 81, 82, 83, 84, 86], "16204": 83, "16205": 73, "1621": [82, 86], "16213": 83, "16217": 84, "16219": 84, "1622": 86, "16223": 83, "1623": [82, 86], "16236": 84, "16239": 81, "16240": 84, "1625": [82, 86], "16252": 83, "1626": [81, 85, 86], "1627": 86, "1628": 86, "16285": 84, "16288": 81, "1629": 86, "163": [76, 82, 84, 86], "1630": [81, 82, 86], "1631": 86, "1632": [81, 85, 86], "1633": 86, "1634": [82, 86], "1635": 86, "1636": 86, "1637": 86, "16373": 81, "16379": 81, "1638": 86, "164": [73, 76, 82, 84, 86], "1640": 86, "1641": 86, "1642": 83, "1643": 86, "1644": 86, "1645": [83, 86], "1646": 86, "1648": [82, 86], "1649": 86, "16491": 81, "165": [76, 82, 84, 86], "1650": 86, "1651": 82, "1653": 86, "16534": 84, "1654": [82, 83], "16541": 84, "1655": [82, 86], "1656": 86, "16563": 76, "1657": 86, "16573": 85, "1658": 86, "1659": 86, "16592": 85, "166": [73, 82, 85, 86, 96], "1660": 86, "166095": 84, "1661": [82, 86], "1662": [82, 86], "1663": 86, "16635": 85, "16636": 85, "1664": 86, "16640": 76, "16646": 81, "1665": 86, "1666": 82, "1667": 82, "16670": 84, "16674": 84, "16676": 84, "1668": [82, 86], "167": [73, 78, 82, 84, 86], "1671": 86, "1672": [82, 86], "167233": 76, "167255": 82, "16728": 81, "1673": 86, "16738": 86, "1674": 86, "1676": 86, "16762": 83, "1677": 86, "1678": 86, "1679": 86, "167e": 81, "168": [73, 82, 84, 86, 88], "1680": 86, "1681": 86, "1682": 86, "1683": 86, "16869": 81, "1687": 86, "16875": 82, "1688": 86, "1689": 86, "169": [73, 76, 82, 84, 85, 86], "169055": 82, "1692": 86, "1693": 86, "1694": 86, "16949": 82, "1695": [83, 86], "16954": 81, "1696": [83, 86], "16967": [81, 82], "1697": [82, 86], "1698": 86, "1699": 86, "17": [73, 74, 76, 79, 81, 82, 83, 84, 85, 86, 95], "170": [73, 76, 82, 84, 86], "1700": 83, "1701": [49, 86], "1702": 86, "1702991": 78, "1703": [82, 86], "1704": 82, "1705": [82, 86], "17067": 81, "1707": 86, "17078": 81, "17079": 83, "1708": 86, "1709": 86, "17099": 81, "171": [78, 82, 84, 85, 86], "1710": 86, "1711": 86, "1712": 86, "17122": 95, "1713": 86, "17132": 84, "17133": 84, "1715": 86, "1716": 86, "1717": 86, "17174": 82, "17175": 81, "1719": 86, "172": [3, 78, 82, 84, 86], "1720": 82, "1721": 86, "1722": 86, "1723": 86, "172395": 82, "1724": [82, 86], "17247": 85, "17249": 85, "1725": 85, "17253": 81, "17261": 81, "1727": [83, 86], "1728": [85, 86], "1729": [82, 86], "172960": 82, "173": [73, 74, 82, 86], "1730": 86, "173009": 82, "1731": [82, 86], "1732": 86, "1734": [82, 83, 86], "1735": 86, "17357": 81, "1736": 86, "1738": [83, 86], "1739": [81, 82], "174": [82, 84, 86], "1740": 86, "1741": [82, 86], "17418": 81, "1742": [82, 86], "174263": 82, "1743": 82, "1744": 86, "17440": 82, "1745": 82, "174532": 82, "174581": 82, "1746": [81, 82, 86], "1747": 86, "174758": 82, "17479": 82, "17482": 82, "1749": [81, 86], "175": [73, 81, 82, 86], "1750": 86, "1751": 86, "1752": [82, 86], "1753": 86, "17531": 85, "17534": 81, "1754": 86, "1755": 82, "1756": [83, 86], "1758": 86, "1759": 84, "176": [82, 84, 85, 86], "1760": 86, "17610": 82, "1761030": 78, "1762": [82, 86], "176235": 82, "1763": 86, "1764": [84, 86], "1765": 86, "176558": 82, "1769": 86, "177": [73, 81, 82, 84, 86], "1770": 86, "17706": 81, "1772": [81, 82, 84], "1773": 82, "1774": [84, 86], "1776": 86, "1777": 86, "17776": 82, "178": [73, 78, 82, 84, 86], "1781": 86, "1782": [82, 86], "1783": 86, "1784": [82, 86], "17851": 81, "1786": [83, 86], "17861": 81, "17864": 81, "17869": 86, "1787": [82, 86], "17887": 95, "179": [82, 86], "1790": 86, "1792": 82, "1794": 86, "1795": [82, 86], "1796": 85, "17961": 81, "1798": [82, 86], "1799": 86, "18": [53, 59, 60, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 95], "180": [53, 73, 76, 82, 84, 86], "1800": 85, "18025": 81, "1803": 81, "1805": 86, "1806": 81, "180658": 85, "1807": [82, 86], "181": [82, 84, 86], "1810": 86, "1812": 85, "1814": 83, "1817": 81, "1818": 86, "182": [82, 84, 85, 86, 95], "1820": 86, "18212": 81, "1822": 86, "18238": 81, "18246": 82, "18268": 82, "18283": 81, "18285": 82, "18292": 82, "18294": 82, "183": [82, 84, 86], "1830": 83, "1833": 82, "18338": 81, "18343": 82, "1835": 84, "18353": 81, "1836": [84, 86], "1837": [82, 84], "1838": [82, 86], "184": [73, 82, 84, 86], "1841": 86, "1842": [82, 86], "1843": [74, 86], "18439": 81, "1844": 88, "1845": 85, "18454": 81, "18468": 81, "1848": 82, "185": [73, 76, 82, 86, 87], "1851": 86, "1852": 86, "1853": 82, "1856": 83, "1859": 85, "186": [73, 76, 79, 82, 86], "18605": 82, "186145": 81, "186203": 81, "18643": 81, "1865": 86, "18662": 81, "1868": 86, "1869": 84, "187": [76, 82, 86], "1870": [81, 85], "18709": 81, "1871": [82, 86], "1872": 81, "1873": [82, 85], "1875": 82, "1876": [81, 84], "18766": 82, "1879": 86, "188": [82, 84, 86], "1881": 81, "18814": 81, "1883": [82, 86], "18836": 84, "18839": 86, "18862": 81, "1887": 86, "18887": 81, "189": [73, 82, 85, 86], "1890": [75, 86], "18919": 84, "1893": 86, "1894": 86, "1896": 86, "1897": 86, "18971": 81, "19": [40, 73, 78, 79, 81, 82, 83, 84, 85, 86, 87, 90, 95], "190": [73, 79, 82, 84, 86], "1900": 86, "19024": 86, "1903": 86, "19032": 73, "19036": 81, "1904": 86, "1907": 81, "19084": 81, "191": [82, 86, 96], "19105": 81, "1912": [81, 86, 95], "1913": 86, "19137": 81, "1914": 86, "19154": 81, "19159": 73, "1916": 86, "1917": 84, "19172": 84, "19177": 73, "19181": 81, "192": [3, 73, 76, 82, 84, 86], "1920": [82, 86], "1921": 95, "19222": 81, "1923": 82, "1924": 81, "19246": 81, "19257": 81, "192715": 81, "1928": 86, "1929": 83, "193": [74, 76, 82, 86], "1930": [82, 86], "1931": 81, "1932": 86, "1933": 86, "193373": 82, "1934": [81, 82, 86], "19349": 81, "1935": 87, "1937": 86, "194": [45, 46, 47, 50, 51, 73, 82, 84, 86], "1940": 86, "19437": 81, "19453": 81, "1947": 86, "19485": 81, "1949": 86, "19499": 81, "195": [73, 78, 82, 84, 86], "1950": 86, "1951": 81, "1955": 82, "19581": 86, "19583": [], "196": [76, 82, 84, 86], "1963": 82, "1965": [81, 86], "19655": 81, "1967": 2, "1969": 82, "197": [82, 84, 85, 86], "1976": 97, "1979": 86, "198": [76, 82, 86], "1982": [18, 40, 84], "19848": 81, "19856": 81, "1986": [11, 86, 97], "19861": 81, "1987": 0, "198714": 82, "199": [2, 73, 81, 82, 84, 85, 86], "1992": [2, 95], "19928": 78, "1993": 81, "199395": 82, "1994": 81, "1995": [82, 97], "1997": [11, 53, 81, 86], "1998": [11, 83], "19984": 81, "1999": [2, 53, 54, 59, 60, 84, 86, 95], "1_integr": 63, "1a": 63, "1d": [11, 53, 82, 86, 87], "1e": [14, 18, 23, 24, 25, 38, 41, 44, 51, 54, 58, 63], "1e4": [53, 59, 60], "1e6": 63, "2": [0, 1, 2, 3, 4, 7, 11, 14, 16, 18, 22, 33, 35, 38, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 58, 59, 60, 61, 62, 63, 64, 66, 68, 69, 72, 73, 74, 76, 78, 79, 80, 81, 83, 84, 85, 86, 87, 88, 95, 96, 99], "20": [11, 14, 16, 38, 40, 41, 46, 47, 48, 51, 53, 54, 58, 59, 60, 63, 66, 72, 73, 74, 75, 78, 79, 81, 82, 83, 84, 85, 86], "200": [47, 50, 53, 54, 63, 69, 72, 73, 76, 82, 84, 85, 86], "2000": [63, 72, 82, 85], "20000": [77, 78, 82, 86], "20011": 85, "2002": [0, 2, 82], "20037": 84, "2004": [11, 35, 64, 84], "2005": 83, "2006": [2, 18, 69], "20061": 81, "2007": 0, "2008": 86, "201": [73, 76, 81, 82, 86], "2010": [0, 53, 59, 60, 79], "2011": [18, 69, 79, 95], "2012": [92, 95, 99], "2013": [95, 99], "20130324": 95, "20130590": 95, "2014": [11, 40, 84, 95, 99], "20149": 81, "2015": [95, 99], "2015_11_10": 48, "2016": [83, 95], "2017": [40, 95], "20171": 81, "20176": 81, "2018": [18, 40, 75, 79, 84, 95], "20187": 81, "2019": [85, 95], "202": [82, 86], "2020": [11, 35, 82, 84, 86, 95], "2021": [73, 74], "2022": [72, 84, 92, 95], "2024": 84, "20247": 81, "20254": 84, "2029": 82, "203": [73, 81, 82, 84, 85, 86], "20310": [], "20311": 86, "20324": 76, "2033": 83, "20340": 81, "20347": 83, "20368": 76, "203702": 84, "203731": 84, "2038": 83, "20382": 84, "2039": 86, "20394": 84, "20395": 84, "204": [78, 82, 86], "2040": 82, "20401": 81, "20413": 84, "20427": 86, "2043": 81, "2044": 86, "20449": 84, "2045": 86, "20450": 86, "2047": 86, "2049": [82, 86], "205": [2, 73, 76, 78, 81, 82, 84, 86], "20518": 84, "20519": 84, "2052": [82, 86], "20521": 81, "2053": 86, "20533": 84, "2055": 75, "20587": 85, "20596": 86, "206": [82, 86], "20604": 86, "20606": 84, "2061": 81, "2063": [82, 83], "2065": 82, "2066": 86, "20673": 84, "20676": 81, "20682": 84, "20683": 84, "20684": 84, "2069": [82, 86], "20695": 81, "20696": 81, "207": [75, 82, 84, 86], "20700": 84, "2071": 82, "2076": 86, "20760": 86, "2077": 86, "20779": 86, "20789": 84, "20791": 78, "20793": [81, 84], "20798": 84, "20799": 84, "208": [73, 78, 82, 86], "20815": 82, "20816": 81, "20817": 82, "20821": 81, "20824": 84, "20831": 84, "20834": 81, "20836": 82, "2084": 75, "20848": 81, "2085": 86, "20874": 82, "20887": 82, "20899": 82, "209": [82, 84, 86], "20903": 82, "20905": 82, "20908": 84, "20916": 84, "20917": 84, "20924": 82, "20929": 82, "20934": 82, "20935": 82, "20936": 82, "20938": 82, "20941": 82, "20942": 82, "20943": 81, "20944": [82, 84], "20945": 86, "20949": [82, 86], "2095": [], "20950": 82, "20952": 82, "209577": 85, "20958": 82, "20961": 82, "20964": 82, "209642": 85, "209657": 85, "20966": 82, "20967": 82, "209673": 85, "2097": 86, "20971": 82, "209715": 85, "20972": 82, "209725": 85, "20973": 82, "209735": 85, "20974": 82, "20975": 82, "20976": 82, "20977": 82, "209773": 85, "209775": 85, "20978": 82, "209787": 85, "20979": 82, "20982": 82, "20983": 82, "20984": 82, "20985": 82, "20986": 82, "20988": 82, "2099": 82, "20990": 82, "20992": 81, "20999": 82, "20e": 84, "20k": 1, "20th": [47, 54, 63, 66, 69, 72], "21": [73, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88], "210": [78, 82, 86, 87], "21000": 82, "21001": 82, "21005": 82, "2101": 86, "21012": 82, "21022": 82, "21025": 82, "21027": 82, "21028": 82, "21029": 82, "21033": 82, "21039": 82, "2104": 86, "21047": 81, "2105": [82, 86], "21054": 82, "21058": 82, "21088": 81, "21094": 82, "211": [3, 82, 85, 86], "2111": [81, 86], "21115": 84, "21127": 84, "21128": 84, "21131": 82, "21137": 84, "2114": 83, "21140": 86, "2115": [84, 86], "21163": 82, "21167": 81, "21172": 84, "21178": 82, "21179": 81, "2118": 82, "2119": 84, "21193": 81, "212": [73, 78, 82, 84, 86], "21208": 82, "21212": 82, "21221": 82, "21222": 76, "2123": 86, "21237": [], "21238": 86, "2125": [74, 84], "2127": 86, "21271": 82, "2128": 82, "21281": 86, "21289": 84, "2129": 82, "213": [73, 76, 82, 84, 86], "2130": 86, "21300": 84, "21302": 84, "21324": 81, "21338": 86, "2134": 86, "21351": 81, "21355": 86, "21363": 76, "2137": [81, 86], "21371": 86, "2138": 81, "21382": 81, "21387": 81, "213880": 85, "2139": 83, "214": [78, 82, 84, 86], "21401": 76, "21403": 81, "21412": 84, "21416": 86, "21418": 84, "21419": 84, "21423": 81, "21426": 81, "2143": [85, 86], "21432": 86, "21436": 81, "21443": 81, "21449": 86, "2145": 82, "21454": 81, "21460": 86, "21465": 81, "2147": 86, "2149": 86, "215": [78, 82, 84, 86], "2150": 86, "21502": 81, "21506": 81, "21507": 86, "21529": 86, "2153": 83, "21540": 76, "2157": [82, 86], "2159": 86, "216": [82, 86], "21635": 81, "21636": 76, "21637": 76, "21639": 76, "21649": 76, "21656": [81, 86], "2166": 81, "2168": [82, 86], "216892": 84, "21691": 81, "216938": 84, "217": [82, 84, 86], "2171": 86, "21713": 82, "2173": 83, "21735": 81, "21740": 82, "21747": 83, "21759": 86, "2176": [81, 82], "21765": 82, "2177": 82, "2178": 73, "21781": 86, "2179": 82, "21795": [82, 84], "218": [73, 82, 86], "2180": 83, "21806": 82, "218080": 86, "21809": 82, "21821": 82, "21822": 82, "21823": 81, "21826": [82, 86], "218270": 90, "2183": 82, "21831": 82, "21832": 82, "21833": 82, "218334": 86, "2184": 82, "21844": 82, "21845": 82, "2185": 86, "21858": 81, "2186": 86, "2187": 82, "2188": 86, "21889": 82, "2189": 76, "21894": 81, "21896": 82, "219": [3, 73, 82, 84, 86], "219058": 84, "2191": 86, "219140": 84, "219144": 84, "21923": 81, "21926": 81, "2193": [74, 86], "21934": 82, "2194": [40, 82, 84], "21948": 82, "21959": 86, "2197": 79, "2198": 86, "21992": 86, "21a": [84, 85], "21b": 85, "21c": 85, "22": [2, 3, 73, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 95, 96], "220": [73, 82, 84, 86], "2202": 82, "22074": 82, "2208": 85, "22084": 76, "22093": 81, "221": [82, 86, 96], "2211": 86, "22117": 86, "22118": 81, "2213": [82, 86], "2215": 86, "22177": 86, "22185": 86, "22193": 81, "222": [75, 76, 82, 84, 85, 86], "22206": 86, "2223": 86, "22246": 81, "222563": 84, "2226": 83, "2227": 83, "22282": 86, "22294": 86, "223": [73, 82, 86], "2230": 86, "2231": 81, "22329": 81, "2234": [82, 86, 87], "2235": [81, 86], "22352": 81, "2236": 82, "2237": [82, 85], "2238": 82, "224": [73, 81, 82, 86], "22401": 86, "2242": 86, "22424e": 86, "22429": 86, "2243": [82, 86], "2244": 86, "22443": 81, "2246": 82, "2247": 82, "22476": 86, "22482": 81, "2249": [], "225": [73, 76, 82, 85, 86], "2250": [82, 86], "2251": 82, "2252": [81, 82], "2253": 82, "22531": 81, "225340": 86, "2254": 81, "2255": [82, 85], "22555": 76, "22562": 82, "22587": 81, "2259": 82, "226": [76, 82, 86], "2260": [82, 86], "22605": 82, "22611": 81, "22620": 86, "2263": 86, "22640868": 95, "2266": 82, "22665786": 95, "22668": 81, "2268": 82, "2269": 86, "22699": 86, "227": [76, 81, 82, 85, 86], "2270": [81, 85], "2271": 81, "22713": 81, "2272": [82, 85], "22722": 81, "22740": 81, "2275": 82, "22761": 81, "22762": 86, "22771": 86, "22778": 86, "2278": 86, "22785": 86, "228": [82, 84, 86], "2282": 86, "22837": 82, "2284": 82, "228434": 86, "2285": 85, "2288": [85, 86], "2289": 81, "229": [82, 86], "2290": 82, "22907": 86, "22936": 81, "22938": 86, "2294": 86, "22943": 76, "22949": 86, "2295": 86, "22951": 86, "2296": 86, "2298": 82, "2299": 82, "22nd": 99, "23": [40, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86], "230": [40, 69, 82, 86], "23008": 86, "2301": 86, "2302": 86, "23046": 86, "2306": [85, 86], "2308": 86, "23081": 81, "2309": 82, "231": [76, 81, 82, 84, 86], "23105": 81, "23108": 82, "2311": 86, "2312": 82, "23127": 81, "2313": 82, "2315": 86, "2316": 82, "2317": 81, "2319": [82, 86], "232": [73, 82, 83, 86, 95], "23215": 81, "2327": 82, "23278": 86, "23289": 81, "2329": 86, "233": [82, 86], "2330": 83, "2331": 81, "23317": 78, "2332": [82, 86], "2333": [82, 86], "23331": 82, "2334": 83, "23343": 82, "2338": 86, "23386": 82, "23389": 81, "23395": 81, "234": [82, 86], "23402": 82, "23403": 82, "2341": 86, "23413188": 95, "2342": [82, 86], "23437": 81, "2344": 86, "2346": 81, "2347": [82, 86], "2348": 81, "23485": 81, "2349": 86, "23494": 81, "23495": 81, "235": [79, 82, 85, 86], "2350": 84, "23507": 85, "2351": 82, "2352": [82, 86], "23529": 86, "2354": 86, "2355": 86, "23553": 81, "2356": 86, "2357": 86, "2358": 86, "2359": 81, "236": [81, 82, 86], "2361": [81, 82], "23623": 81, "2363": 82, "2364": 83, "2366": 85, "23663": 81, "2367": 86, "23689": 81, "23691": 81, "237": [82, 85, 86], "23706": 81, "2371": [82, 86], "2372": 85, "2374": [83, 86], "23748": 86, "2376": 83, "2377": 82, "2378": 86, "23781811553089": 3, "23793153": 95, "238": [76, 81, 82, 86], "2380": 86, "23809": 81, "2381": [82, 86], "2382": 81, "23820": 81, "2383": 81, "23841": 81, "2385": 81, "23864": 81, "2387": [85, 88], "23872": 81, "23873": 81, "23877": 86, "2388": 82, "23881": 81, "23884": 81, "23887": 86, "2389": 81, "23895": 83, "239": [76, 82, 84, 85, 86, 95], "2390": 81, "2392": 81, "2395": 86, "23965": 81, "2398": 83, "23983": 81, "23985": 86, "24": [73, 76, 77, 78, 81, 82, 83, 84, 85, 86, 95], "240": [76, 82, 86], "24000": 81, "24005": 81, "24016": 81, "24019": 81, "24022": 81, "2403": 86, "24032": 73, "2404": [], "240463": 85, "24069": 85, "2407": [], "2408": 86, "2409": 83, "241": [78, 81, 82, 84, 86], "2411": 86, "2412": [83, 86], "24126": 81, "2416": 82, "242": [73, 79, 82, 84, 85, 86, 95], "2420": 86, "24206": 81, "24217": 81, "2424": 82, "2425": 82, "24255": 83, "2426": 86, "24269": 81, "2427": 86, "24276": 81, "24289": 81, "2429": 86, "24297": 82, "243": [82, 84, 86], "2430": 86, "24303": 81, "24305": 81, "24326": 81, "24331": [81, 85], "24338": [86, 87], "2434": 86, "24341": 86, "2435": 86, "2436": 86, "24376": 81, "24379": 81, "2438": 82, "24389": 81, "2439": [82, 86], "24397": 81, "244": [78, 82, 84, 86], "24425": 81, "2443": 86, "2445": 86, "24455": 86, "2447": 81, "245": [0, 82, 85, 86], "24507": 81, "24507780": 95, "24510": 81, "2452": 86, "2453": 83, "24538": 81, "24540": 81, "24541": 83, "24546": 81, "24552": 81, "2456": [74, 82, 86], "2457": 86, "24576": 86, "2458": 86, "24586": 81, "2459": 86, "24597": 81, "246": [73, 76, 82, 83, 86], "2460": 86, "24607": 81, "2461": 86, "24614": 81, "2462": 86, "24623": 81, "24629": 81, "2463": [3, 82, 86], "24631": 81, "24633409": 95, "2464": 86, "24652": 81, "2466": 81, "2467": 86, "2468": 86, "246904": 84, "247": [81, 82, 84, 86], "24706": 81, "24712": 86, "2472": 86, "2473": 82, "2474": 82, "24742": 81, "24748": 81, "2475": [75, 85], "24755": 81, "24757": 81, "247651": 76, "24780": 81, "2479": 86, "24795": 81, "248": [73, 82, 84, 86], "2480": 85, "2481": [85, 86], "24812": 81, "24816": 85, "2482": 86, "24826": 81, "2483": [82, 86], "24848": 85, "2485": [], "24860": 81, "24863": 81, "2488": 81, "24889": 81, "249": [73, 82, 84, 86], "2490": 85, "24901": 81, "2491": 86, "24914152": 95, "24914169": 95, "2492": 86, "24929": 81, "2493": 82, "2494": [82, 85], "24972": 81, "24978": 81, "2498": 86, "24988": 81, "2499": [82, 83], "24999": 81, "25": [1, 11, 43, 47, 53, 63, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86], "250": [47, 54, 63, 69, 72, 76, 81, 82, 84, 86, 95], "2500": 86, "25006873": 95, "25013": 83, "25018": 81, "25023": 81, "25027": 85, "2503": [82, 86], "25031": 81, "2504": 86, "25045": 86, "25051": 81, "25058": 81, "25059": 81, "25067": 81, "2507": 86, "2508": 86, "25082": 86, "251": [73, 82, 84, 86, 88], "2510": 83, "25119": 81, "2512": [82, 85], "2513": 82, "25135": 81, "25136092": 95, "25139": 83, "25140": 81, "251517": 85, "2516": 86, "2517": 86, "25187": 81, "2519": 86, "25192": 86, "25193": 81, "25198": 81, "252": [76, 81, 82, 84, 86], "25214": 81, "25226": 81, "25232": 85, "25238": 81, "2524": 86, "25242914": 95, "2525": 86, "2526": 83, "2527": [3, 82, 86], "25285": 81, "25286849": 95, "2529": 86, "253": [73, 82, 84, 86], "2530": 86, "2531": 81, "25318": 81, "2532": 82, "25323": 81, "2533": [84, 86], "25355": 84, "25357": 81, "2536": 82, "25362050": 95, "2539": 86, "254": [76, 78, 81, 82, 86], "2540": [85, 86], "2541": [], "25415": 79, "2543": 86, "25438": 81, "25442": 81, "25453": 81, "25453071": 95, "2546": 86, "25461": 81, "25466": 84, "25474": 81, "25478847": 95, "25479": 81, "2548": 86, "25484844": 95, "255": [40, 73, 75, 82, 84, 86], "25506": 81, "2551": 86, "25511": 81, "2552": 86, "255222": 86, "2554": 86, "25547": 81, "2555": 83, "25565": 81, "2557": 82, "25577": 81, "2558": 86, "255800": 76, "25585": 81, "2559": 86, "25596": 81, "256": [53, 73, 75, 78, 82, 86, 87], "2560": 86, "25616": 86, "2562": 86, "2564": [78, 86], "2565": 82, "25657": 81, "25661": 81, "25664746": 95, "25664747": 95, "2567": 86, "25673": 81, "25676": 81, "25686": 83, "2569": 86, "25694": 81, "25696": 81, "25697": 86, "256\u00b3": [82, 86, 87], "257": [73, 78, 79, 82, 86], "2570": 86, "2571": 86, "25710": 81, "25717": 81, "25720": 81, "25723925": 95, "2573": 86, "25735": 81, "2574": 86, "25741": 81, "25744": 81, "2575": 86, "25751308": 95, "2576": 82, "25765": 81, "25766": 81, "2577": 86, "2578": 74, "25781": 81, "25781634": 95, "25787": 81, "258": [76, 81, 82, 86], "2583": 86, "25844": 81, "25846": 81, "2585": 82, "2588": 81, "259": [73, 78, 81, 82, 84, 86], "2590": 86, "25901": 81, "2591": 86, "25925": 81, "2593": 86, "25938": 81, "2594": [82, 86], "259466": 82, "2596": 83, "25965": 81, "2597": 82, "2598": 86, "25988": 81, "26": [73, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 95, 96], "260": [73, 75, 81, 82, 86], "26008": 81, "2602": 86, "26023": 81, "2604": 82, "2605": 86, "26057680": 95, "2606": 86, "26069": 81, "2608": 81, "2609": 81, "261": [73, 78, 82, 86, 95], "2611": 81, "26118": 81, "26121": 83, "2613": [82, 86], "26130": 86, "26136": 84, "2615": 86, "2616": 86, "26167": 84, "26174": 84, "2618": 86, "2619": 86, "26191": 81, "262": [73, 75, 82, 83, 84, 86], "2620": [83, 86], "2621": [85, 86], "26211": 86, "26215": 81, "2622": 86, "2623": 82, "26244": 81, "2625": 85, "26252": 84, "2626": 86, "26279": 86, "26280336": 95, "26289": 81, "263": [49, 73, 76, 82, 84, 85, 86], "26302": 86, "2631": 86, "2632": [82, 86], "2633": 86, "26334": 81, "2634": 86, "26341": 81, "26352473": 95, "2637": 86, "2638": 86, "2639": 85, "264": [73, 82, 84, 86], "2640": 86, "26413": 85, "2642": 86, "2643": 81, "2646": 86, "2647": 86, "26476": 81, "2648": 86, "26482": 81, "2649": 82, "26494": 81, "265": [73, 78, 81, 82, 86], "2650": 86, "26503": [86, 87], "26504": 81, "2652": [11, 95], "2654": 86, "26549": 81, "26569": 81, "2657": 86, "26575": 81, "2658": 82, "266": [73, 78, 82, 84, 86], "2660": 86, "26616": 81, "2662": 86, "2664": 86, "26646": 81, "26659": 81, "2666": [11, 81], "26661": 81, "2667": 86, "26682": 81, "267": [73, 81, 82, 85, 86], "2670": 86, "2671": [81, 86], "2673": 86, "2675": [], "267504": 74, "26755": 83, "2676": 86, "2677": 86, "26774": 81, "2679": 82, "268": [73, 78, 81, 82, 86], "2680": 86, "2681": 86, "2682": [], "2683": 86, "2684": 85, "2685": 86, "2686": 81, "26874": 82, "2688": 86, "26887": 81, "2689": 82, "26897": 86, "26898": 81, "269": [81, 82, 84, 86], "2691": [81, 82, 86], "26933": 81, "26934": 83, "2697": 86, "27": [73, 75, 77, 78, 81, 82, 83, 84, 85, 86], "270": [82, 86], "2700": 86, "2701": 86, "2703": 86, "2705": [74, 86], "27050135": 95, "2706": 82, "2708": [83, 86], "27085": 81, "271": [81, 82, 84, 86], "2710": 86, "2711": 83, "27121": 81, "27127": 81, "27143": 81, "2715": 86, "2716": 86, "27169": 81, "27181": 81, "2719": 86, "27191": 83, "272": [73, 76, 78, 82, 86], "2722": 86, "2723": [76, 86], "2724": 81, "27266": 81, "2727": 83, "27272": 81, "2728": [81, 82], "2729": 78, "273": [82, 84, 86], "2730": 86, "27324": 86, "2733": 86, "27368": 81, "274": [73, 81, 82, 86], "27402": 81, "2744": 86, "27443": 83, "27452": 83, "27486": 81, "27493": 81, "275": [76, 82, 84, 86], "27504": 85, "2751": [81, 86], "27533": 83, "2757": 81, "27575": 81, "2758": [81, 86], "2759": 86, "276": [73, 82, 84, 86], "2763": [81, 86], "2766": 86, "27665": 81, "2767": 82, "2768": [85, 86], "277": [73, 82, 84, 86], "2772": [81, 84], "2773": 82, "27743": 81, "278": [76, 81, 82, 84, 85, 86], "27804": [81, 85], "2782": 86, "2783": 82, "27842": 83, "27855": 83, "27862": 83, "27863": 86, "2788": 86, "279": [82, 86], "2790": 86, "2791": 86, "2792": 78, "2793": 86, "27939": 81, "2795": 86, "2796": [82, 86], "27977": 81, "2798": 81, "27980508": 95, "2799": [74, 82], "27_dial": 76, "27_refined_cel": 76, "28": [11, 73, 78, 81, 82, 83, 84, 85, 86, 87, 95], "280": [82, 86, 87], "2800": 86, "2801": 86, "2802": 86, "2803": 86, "2806": 81, "2807": 86, "281": [81, 82, 86], "2810": 83, "2811": 86, "2812": 86, "2814": 86, "2815": 86, "2816": 86, "2817": 86, "2818": 86, "2819": 86, "28197": 86, "282": [18, 69, 73, 82, 86], "28205": 81, "28219": 86, "2822": 85, "2824": 81, "28243": 83, "2825": 86, "28257": 85, "2826": 81, "2827": 86, "2828": 86, "2829": 81, "28293": 83, "283": [78, 82, 84, 86], "28303": 86, "28308": 81, "283277": 87, "2834": 86, "2835": 81, "2839": 86, "284": [82, 86], "28409": 81, "2842": 82, "2843": 86, "2845": 86, "28466": 81, "285": [73, 82, 84, 86], "2851": 78, "28525": 81, "28538": 83, "2856": 83, "28579": 86, "28586": 81, "2859": 86, "286": [73, 81, 82, 84, 85, 86], "28605": 82, "2863": [84, 86], "2865": [84, 86], "2869": [83, 86], "28695": 81, "287": [73, 82, 84, 86], "2871": 86, "2873": 81, "2874": 86, "2875": 86, "2876": 78, "28764": 86, "28766": 81, "2877": 86, "28776": 86, "2878": [82, 85], "28785": 83, "2879": 86, "288": [73, 82, 84, 86], "2880": [], "2881": 86, "2882": [85, 86], "2883": 86, "2884": 86, "28874": 81, "2888": 86, "289": [73, 82, 84, 86], "2890": 86, "28915": 81, "2892": 84, "28935": 74, "2894": 86, "2895": 86, "2896": 86, "28981": 83, "28989718": 95, "28_dial": 76, "28_scale": 76, "28_scaled_unmerg": 76, "28e": 84, "29": [73, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 87, 96], "290": [73, 82, 86], "29002": 81, "29009": 81, "29034": 84, "29035": 84, "2904": [78, 86], "29046": 84, "2905": 86, "29054": 84, "2907": 86, "29087": 81, "291": [73, 74, 82, 86], "2911": 86, "29114": 85, "2912": 83, "2916": [73, 81], "292": [18, 69, 73, 76, 81, 82, 84, 86], "2920": 84, "2922": 86, "2923": [82, 86], "2924": 78, "2928": 83, "293": [82, 86], "29306": 81, "29307": 83, "29309": 81, "2931": 86, "2933": 81, "2934": 86, "2935": [], "2936": 82, "2937": [73, 82], "2938": [82, 86], "2939": 86, "294": [73, 81, 82, 86], "2940": 86, "29400": 73, "2945": 86, "2946": 86, "2949": 86, "2949728": 78, "295": [73, 82, 86], "2950": 86, "2951": 85, "2952": [81, 86], "2953": 86, "29533234": 95, "29543": 81, "29556": 81, "295803077552249": 3, "29589": 81, "2959": 82, "29594": 86, "296": [73, 82, 84, 86], "2961": 86, "2962": 86, "29632": 83, "2964": 86, "2965": 86, "2966": 86, "29662": 83, "29667": 83, "29673": 81, "29676": 85, "29682": 81, "29697": 81, "297": [81, 82, 83, 84, 86], "29717711": 95, "2972": 86, "2973": 86, "2976": 81, "29764": 83, "2978": 83, "2979": [82, 86], "298": [81, 82, 86], "2981": 86, "2982": 86, "2984": 86, "2985": 83, "29869": 81, "2987": 86, "29872002": [75, 95], "2988": 86, "29881": 81, "299": [73, 82, 83, 84, 86], "29905": 81, "2992": 78, "2993": 82, "29952": 83, "2996": 78, "29_dial": 76, "29m36": 83, "2_1": [75, 77, 84], "2_integr": 63, "2d": [1, 2, 12, 14, 47, 54, 63, 98], "2f": 44, "2ul": [10, 12, 26], "2\u03b8": [47, 51, 70, 72], "3": [0, 1, 2, 3, 6, 11, 15, 18, 22, 33, 35, 37, 39, 40, 41, 43, 45, 47, 48, 50, 51, 52, 53, 54, 57, 58, 59, 60, 61, 62, 63, 68, 72, 73, 74, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96, 99], "30": [11, 45, 53, 66, 73, 74, 75, 81, 82, 83, 84, 85, 86, 87, 97], "300": [53, 59, 60, 75, 76, 82, 83, 84, 86], "3000": 86, "30000": 82, "30046": 81, "3005": [78, 86], "30057": 81, "3007": 82, "30075": 81, "300879": 76, "301": [82, 84, 86], "3010": 86, "3011": 86, "3012": 86, "301260": 84, "3013": 86, "3014": 86, "301412": 76, "3016": 86, "3018": 86, "3019": 86, "30198898": 95, "302": [73, 82, 86], "3021": 86, "30225": 83, "3023": 86, "3024": 86, "30251": 81, "30274": 81, "3028": 86, "3029": 81, "303": [81, 82, 86], "3033": 86, "30346": 81, "3035": [81, 86], "30358": 83, "3037": 86, "30376": 82, "30387": 83, "304": [73, 82, 84, 86], "3042": 86, "3045": 82, "30452": 86, "3047": 86, "3048": 86, "304888": 76, "305": [75, 82, 86], "3052": 86, "3053": 86, "30539": 81, "30551": 81, "3056": [81, 86], "3057": 86, "3057089": 78, "306": [73, 82, 84, 86], "3061": 86, "3063": 86, "30649": 83, "307": [73, 81, 82, 86], "3072": 86, "3073": 78, "3075": 86, "3076": 81, "3079": [81, 86], "308": [82, 86, 87], "3080": 86, "3082": [82, 85], "3084": 86, "30869": 81, "3087": 86, "3088": 86, "309": [75, 82, 86, 95], "3091": [82, 86], "3095": 86, "30950396": 95, "3097": [78, 86], "30996": 81, "31": [11, 35, 73, 74, 76, 81, 82, 83, 84, 85, 86, 95], "310": [73, 82, 86], "3100": 86, "31004": 81, "3101": 86, "3103": 86, "3104": 86, "3106": 86, "3107": 86, "31088": 81, "3109": 86, "311": [82, 86], "3112": 86, "3115": 86, "3119": 86, "312": [73, 82, 86], "312213": [], "312214": 86, "3123": 86, "31232": 81, "3124": [], "3126": 86, "31271": 81, "3128": 86, "313": [82, 84, 85, 86], "3132": 86, "31331": 81, "3135": [78, 86], "3137": 86, "3139": 78, "313906": [], "313907": 86, "314": [73, 82, 84, 86], "3140": 86, "3142": [84, 86], "3143": 86, "3144": 84, "3147": 78, "3148": 86, "315": [73, 76, 82, 86], "3151": 78, "3152": 86, "31531": 84, "31547": 84, "3156": 78, "3157": 86, "31578": 83, "3159": 86, "31598": 84, "316": [76, 82, 85, 86], "31601": 81, "31614": 81, "3162": 86, "3163": 86, "3164": 86, "3167": 86, "317": [74, 82, 84, 86], "3171": 86, "31716": 81, "31728": 81, "31729": 81, "317393": 81, "3174": 86, "317541": 81, "3176": 83, "3177": [85, 86], "318": [73, 82, 84, 86], "3180": 86, "3181": 83, "3182": 86, "3183": [], "3184": 86, "3186": [], "3187": 86, "3188": 86, "31898": 83, "319": [76, 82, 86], "3190": 86, "3191": 86, "31911": 81, "3192": 86, "3193": 86, "3194": 86, "31962": 81, "3199": 86, "31e": 84, "32": [73, 75, 76, 81, 82, 83, 84, 85, 86, 96], "320": [82, 86], "3200": 82, "32007": 81, "3202": 86, "32036": 81, "3204": 86, "3205385": 78, "3207": [85, 86], "3208": 86, "3209": 81, "32094": 81, "321": [76, 82, 84, 86], "3210": 86, "3211": 86, "32129": 81, "321472": 79, "3215": 86, "3216": [81, 86], "3218": 86, "3219": [], "321968": 76, "322": [73, 76, 82, 84, 86], "3220": 86, "3221": 86, "3225": 82, "32254063": 95, "3226": [85, 86], "32288": 83, "3229": [82, 85], "323": [73, 82, 84, 86], "3230": [82, 86], "3232": [78, 86], "3233": [78, 86], "3234": 86, "3237": 82, "3238": 81, "3239": 86, "324": [73, 81, 82, 84, 86], "3240": [83, 86], "3241": [40, 84, 86], "3242": 86, "3246": 85, "324979": [], "324980": 86, "325": [82, 84, 86], "325072": [], "325073": 86, "325074": 86, "325189": [], "325190": 86, "3253": 86, "325378": [], "325379": 86, "325380": 86, "325383": [], "325384": 86, "32568": 81, "3258": 86, "326": [73, 82, 86], "3262": 86, "32623": 83, "3264": 86, "32645": 81, "3265": 86, "32658": 85, "3266": 86, "3267": 86, "327": [73, 78, 81, 82, 84, 86], "327038": [], "327039": 86, "327076": [], "327077": 86, "3272": 86, "3273": 86, "3274": 86, "3276": [81, 86], "3277": 86, "328": [73, 74, 79, 82, 86], "3280": 86, "3281": 81, "3285": 81, "3286": 86, "32879": 81, "3288791": 78, "3289": [78, 85], "329": [82, 84, 86], "329174": 82, "3293": 86, "3295": 86, "3296": 86, "3297": 85, "3297608": 78, "3298": 86, "3299": 95, "33": [73, 75, 76, 77, 81, 82, 83, 84, 85, 86, 96], "330": [82, 86], "3302": 86, "33030237": 73, "3304": 86, "3309": 86, "331": [73, 76, 78, 81, 82, 85, 86], "3311": [83, 86], "33153": 81, "3316": [], "3317": 86, "331750": 81, "3319": 82, "331984": 81, "332": [73, 82, 86], "3321": [82, 86], "3323": 86, "3324": 86, "3326": [], "3327": 86, "333": [73, 81, 82, 86], "3330": 86, "33333": 14, "33371": 81, "33398": 81, "334": [73, 82, 86], "33404": 81, "3342": 83, "33424": 81, "3343": 86, "3345": 86, "3346": [83, 86], "3347": 86, "3348": 86, "3349": 86, "335": [74, 76, 82, 84, 86], "33539": 82, "33544": 81, "3358": 86, "3358310": 78, "3359": 86, "33596": 85, "336": [74, 82, 86], "3361": 86, "3362": 88, "3364": 86, "3369": 85, "337": [82, 86], "3375": 85, "338": [45, 46, 47, 50, 51, 76, 82, 86], "33809": 83, "3383": 86, "33843": 81, "338446": 81, "338516": 77, "3386": 86, "338720": 81, "338728": 77, "33883": 85, "33884": 85, "3389": 86, "339": [78, 79, 82, 86], "3394": 86, "33972532": 74, "34": [73, 76, 78, 81, 82, 83, 84, 85, 86], "340": [73, 81, 82, 86, 95], "3400": 85, "3402": 86, "3403": [82, 86], "3407": 86, "3408": [82, 86], "341": [82, 84, 86], "34173": 82, "342": [82, 84, 86], "3420": 86, "34229": 73, "3423": 86, "34241": 81, "3428": 86, "3429": [], "343": [81, 82, 85, 86], "3430": 86, "34304": 81, "3431": 86, "34327213": 73, "3435": 86, "3439": 86, "344": [82, 86], "3440": [], "34444": 83, "3446": 86, "34464": 83, "3449": 86, "345": [54, 73, 75, 82, 85, 86], "3450": 86, "34512": 81, "3455": 82, "34551": 85, "346": [40, 73, 76, 82, 84, 86], "34611": 81, "3463": 86, "3464": 86, "3465": 86, "3466356": 78, "34664": 81, "3467": 86, "347": [73, 82, 86], "3472": 86, "34747533": 95, "3477": 86, "3479": 86, "348": [82, 86], "3480": 86, "3484342": 78, "3489": 81, "349": [82, 84, 86], "3490": [81, 86], "34911": 83, "3493": 86, "3495": 86, "3496": 86, "3499": 83, "35": [0, 2, 3, 73, 74, 77, 81, 82, 83, 84, 85, 86], "350": [73, 82, 86], "35019": 81, "3502": 86, "3503": 82, "3508": 83, "3509": 86, "351": [82, 86], "3510": 35, "3512": 86, "3514": [], "35145": 81, "3515": 86, "352": [49, 73, 82, 86, 95], "35204": 83, "35249": 81, "3525": [75, 86], "3526": 86, "353": [73, 78, 82, 86], "35304": 83, "3532": 86, "35339": 81, "3534": 86, "3535": 86, "3537": 86, "3539": 86, "35395": 83, "354": [82, 86], "35422": 85, "3546": 86, "3548": 86, "35488": 81, "3549": 86, "35492": 85, "355": [82, 86], "3551": 86, "3554": 86, "3555": [83, 86], "3558": 81, "35593": 85, "356": [79, 82, 86], "3560": 81, "3561": 81, "3564": [82, 86], "35647922": 95, "3565": [81, 82], "357": [82, 86, 95], "3572": 86, "3577": 86, "3578": 86, "35789": 81, "358": [75, 82, 86], "3580": 86, "3581": 81, "3582": 86, "3586": 86, "3588": 86, "359": [73, 76, 82, 83, 86], "35943": 83, "3599": 86, "35999": 86, "36": [40, 53, 59, 60, 73, 76, 81, 82, 83, 84, 85, 86], "360": [40, 81, 82, 84, 86, 87], "36000": [86, 87], "3601": 86, "3602": 86, "3603": 84, "3609": 86, "361": [73, 82, 86], "36137": 83, "3618": 86, "3619": 86, "362": [82, 84, 86, 87], "3620": 86, "3622": 86, "3623": 86, "3624346": 78, "36268": 81, "3628": [84, 86], "3629": [82, 86], "363": [73, 82, 84, 86], "3630": 86, "3631": 84, "3632": 86, "3635": [84, 86], "36377": 81, "36386": 83, "364": [73, 81, 82, 86], "3641": 86, "3644": 86, "36458": 81, "3646": 86, "3647": 86, "3648": 86, "36483": 81, "365": [73, 76, 82, 84, 86], "3655": 86, "36559": 81, "3657": [], "3658": 86, "3659": 86, "365e": 86, "366": [73, 76, 81, 82, 86], "3660": 86, "366022": 86, "36619": 81, "3662": 86, "36662": 74, "3669": 86, "367": [82, 86], "36708": 81, "36731": 81, "3674": 86, "3674101744536096": 76, "3676": 86, "36776": 81, "3678": 86, "36795": 81, "368": [82, 84, 86], "3680": 86, "3681": 86, "3683": [81, 86], "36858": 81, "368590": 86, "368699": 86, "36893": 81, "369": [82, 85, 86, 95], "3692": 86, "3693": 86, "36983": 81, "3699": 82, "37": [11, 53, 64, 73, 74, 76, 77, 81, 82, 83, 84, 85, 86], "370": [76, 81, 82, 86], "37002": 81, "3701": 86, "3707": 86, "37074": 83, "371": [73, 76, 82, 85, 86], "3711": 86, "37139": 83, "3714": 86, "3717": 86, "3718": 78, "372": [82, 85, 86], "3723": 74, "3725": 81, "373": [82, 86], "37309": 81, "3730940": 82, "3731": 86, "3732": 86, "3734": 82, "37366": 81, "3737": [81, 86], "37377": 81, "374": [73, 82, 86], "37408": 81, "3742": 86, "37466": 85, "3748": 86, "375": [73, 82, 86, 87], "3750": 86, "37528": 81, "37577": 81, "37586": 83, "376": [82, 86], "3760": 86, "3765": 83, "3767": 86, "377": [82, 86], "3771": 86, "3773": 82, "3774": 82, "3776": [81, 86], "3777": 86, "378": [82, 83, 86], "37822": 81, "37838": 81, "37843": 81, "3785": 86, "3788": 82, "379": [73, 82, 86], "3790": 86, "38": [3, 40, 73, 76, 78, 81, 82, 83, 84, 85, 86, 96], "380": [82, 86], "3800": 81, "3803": 81, "3805": 86, "381": [82, 84, 86], "3810": 85, "3813": 85, "3815": 86, "38155": 81, "3817": 86, "3819": 86, "382": [82, 86], "3826": 86, "383": [82, 84, 86], "38322": 81, "3833": 86, "3835": [81, 86], "38365": 81, "3837": 86, "38373": 81, "384": [82, 85, 86], "385": [82, 84, 86, 95], "38505": 81, "38555": 81, "38596": 83, "386": [73, 82, 86], "38606": 83, "3862": [], "3863": 86, "3864": 82, "3867": 86, "3868": 86, "3869": 86, "387": [82, 86], "3870": 86, "3877": 86, "388": [82, 86], "3881": 86, "3883": 86, "38874": 81, "38875": 81, "3888": 82, "3889": 86, "38894": 81, "38899": 81, "389": [73, 76, 82, 86], "3894": 82, "38962": 81, "3898": 82, "3899": [82, 86], "39": [73, 77, 78, 81, 82, 83, 84, 85, 86, 96], "390": [82, 83, 84, 86], "3905": 86, "39065": 81, "3908": 81, "3909": 81, "391": [82, 86, 87], "3916": 82, "392": [82, 83, 86], "39219": 81, "39228": 81, "3923": 86, "39245": 83, "39246": 81, "3926": 86, "3927": 86, "3929": 86, "39294": 83, "393": [73, 82, 86], "39314": 81, "3933": 82, "3935": 81, "3939": 82, "394": [73, 81, 82, 85, 86], "3944": 82, "39465": 81, "39499": 81, "395": [82, 86], "3954": 86, "396": [82, 86], "3961": 86, "39675": 81, "3968": 82, "39692": 81, "397": [73, 82, 86], "39711": 81, "3973": 86, "39733": 86, "398": [82, 86], "39851": 81, "399": [11, 64, 76, 82, 83, 84, 85, 86, 95], "39922": 83, "3d": [1, 11, 12, 47, 52, 53, 63, 74, 82, 83, 86, 87, 96, 98], "3ded": [74, 80], "3deg": [40, 84], "3e": 88, "3rd": 97, "4": [0, 1, 2, 3, 11, 16, 18, 22, 33, 35, 40, 43, 44, 45, 46, 47, 48, 50, 51, 53, 54, 60, 63, 64, 69, 70, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 97], "40": [62, 73, 74, 76, 81, 82, 83, 84, 85, 86, 87, 96], "400": [76, 81, 82, 85, 86], "400223": 76, "40028": 81, "40052": 81, "4006": 82, "401": [82, 83, 84, 86], "40106": 81, "4011": 82, "40123": 83, "40137": 81, "4014": 82, "40149": 81, "4015": 82, "40151": 81, "4018": [82, 86], "40185": 81, "40191": 81, "402": [82, 86], "4020": 0, "4021": 86, "4022": [], "4023": 82, "4029": 81, "40298": 83, "403": [74, 82, 83, 84, 86], "4034": 82, "40342": 81, "40359": 82, "4038": 81, "404": [82, 86], "4043": 82, "4047": 86, "4049": 81, "405": [18, 40, 81, 82, 83, 84, 86, 95], "4052": 86, "40525": 81, "4053": [], "40577": 81, "4059": 85, "406": [81, 82, 86], "4060": 86, "4061": 86, "4063": 86, "40658": 81, "407": [11, 82, 86], "4071": 86, "40725": 81, "4073": 86, "4074": 86, "4075": 82, "4076": [82, 86], "4077": [82, 84], "4078": 82, "4079": 86, "408": [73, 82, 86], "40816": 81, "40848": 81, "40867": 81, "4087": 86, "409": [11, 64, 73, 81, 82, 84, 85, 86], "4094": 86, "40955": 81, "41": [0, 73, 75, 78, 79, 81, 82, 83, 84, 86, 88], "410": [18, 40, 82, 84, 86, 95], "4100": 86, "4101": 86, "4102": 82, "41024": 81, "4103": 81, "41055": 81, "411": [81, 82, 86], "4111": [81, 82], "4112": 82, "41136": 87, "4114": 82, "41145": 81, "41177": 81, "412": [82, 85, 86], "4121": 82, "4122": 81, "4128": 81, "413": [11, 73, 82, 86], "4130": 82, "41311": 81, "414": [82, 86], "4141": 82, "41469": 83, "4147": 82, "4148": 82, "415": [82, 84, 86], "4152": 82, "41568": 83, "41585": 81, "415898": 76, "416": [82, 86], "4161": 82, "41622": 86, "41623": [], "4165": 86, "41673": 81, "417": [81, 82, 85, 86], "41713": 81, "4172": 82, "418": [82, 84, 86], "41832": 85, "419": [73, 74, 82, 86], "41c": 84, "42": [4, 53, 59, 60, 64, 72, 76, 78, 81, 82, 83, 84, 85, 86, 87, 96], "420": [82, 84, 86], "42044": 81, "42048": 76, "421": [73, 76, 82, 84, 85, 86], "4212": 88, "42183": 88, "422": [73, 76, 82, 84, 86], "4229": 79, "423": [73, 82, 86], "424": [73, 82, 86], "4242": 4, "4243": 82, "42443": 82, "42447": 81, "4247": 81, "42478": 83, "4249": 81, "425": [81, 82, 85, 86], "4256": 82, "4257": 84, "42575": 81, "426": [73, 82, 86], "4263": [85, 86], "4265": 81, "4266": 86, "42663": 81, "42672": 81, "427": [73, 82, 86], "42778": 81, "428": [73, 82, 86], "42802": 81, "42803": 81, "42881": 81, "42882": 86, "4289": 86, "429": [73, 74, 81, 82, 86], "4291": 86, "42c": 84, "43": [73, 78, 79, 81, 82, 83, 84, 85, 86], "430": [82, 86], "43068": 81, "431": [82, 86], "4310": [81, 86], "43153": 81, "432": [73, 82, 86], "43205": 81, "4328": [74, 86], "433": [82, 86], "43312": 81, "4333": 84, "4335": 82, "43388": 81, "434": [82, 86], "4340": [84, 86], "43408": 81, "4341": 82, "4345": 78, "43483": 81, "435": [74, 82, 86], "4352": 83, "43547": 81, "436": [73, 82, 86], "43612": 82, "43642": 82, "43661": 82, "4368": 86, "4369": 86, "437": [78, 82, 86], "4371": 95, "43778": 82, "4378": 81, "4379": [81, 86], "438": [75, 82, 86], "439": [73, 76, 82, 86], "44": [48, 78, 81, 82, 83, 84, 85, 86], "440": [82, 86], "44019": 81, "4407": 82, "44084": 81, "4409": 82, "441": [82, 84, 85, 86], "44117": 81, "442": [73, 82, 86], "44268": 81, "443": [82, 86], "44329": 82, "44341": 82, "444": [2, 76, 82, 83, 86], "4441": 86, "445": [82, 85, 86], "4450": 86, "44533": 81, "44535": 82, "446": [82, 86], "44653": 81, "447": [81, 82, 84, 86], "44711": 81, "44719": 81, "44757": 81, "4479": 82, "448": [76, 82, 86], "4483": 82, "449": [82, 86], "44911": 81, "4492": 86, "44932": 81, "44994": 81, "45": [11, 53, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 88], "450": [82, 86], "45054": 81, "4508": 74, "451": [82, 86], "4516": 86, "452": [73, 74, 82, 86], "4526": [], "453": [82, 86], "45303890619488": 3, "45355": 81, "454": [74, 82, 86], "455": [73, 74, 82, 85, 86], "45501": 81, "45551": 82, "4556": 82, "45564": 81, "456": [82, 86], "45694": 85, "457": [2, 81, 82, 84, 86], "4574": 82, "458": [2, 81, 82, 86], "459": [73, 82, 86], "4594": 84, "45e": [], "46": [49, 73, 76, 79, 81, 82, 83, 84, 85, 86], "460": [74, 82, 85, 86], "4603": 84, "46071": 81, "461": [76, 82, 86], "46152": 85, "46181": 81, "462": [82, 86], "46232": 81, "46252": 81, "46257": 83, "46291": 83, "463": [76, 82, 86], "46301": 81, "46307e": 86, "46332": 85, "46360": 84, "46365": 81, "464": [2, 82, 86], "4641": 82, "465": [82, 86], "466": [82, 86], "466492": 85, "46698": 81, "467": [81, 82, 86], "4673": 84, "4675": [84, 86], "468": [82, 86], "46806": 82, "46855": 83, "469": [82, 86], "46902": 83, "46907": 81, "46951": 83, "4698317405529955": 3, "47": [40, 74, 75, 81, 82, 83, 84, 85, 86, 95], "470": [82, 86], "4701": 81, "4706": 84, "4707": [81, 84], "47078": 81, "471": [73, 82, 84, 86], "47124": 81, "4718": 73, "472": [73, 81, 82, 86], "472000": 85, "47213": 83, "47216": 81, "47248": 81, "4727": 82, "4729": [79, 86], "473": [82, 86], "47301": 82, "47338": 81, "47367": 82, "474": [82, 84, 86], "47418": 82, "4747": 81, "475": [73, 82, 86], "47572": 81, "4759": 84, "476": [81, 82, 86], "47641": 82, "47678": 83, "477": [73, 82, 86], "47756": 82, "4777": 82, "47797": 81, "478": [81, 82, 86], "47841": 81, "47859": 82, "479": [82, 86], "4791": 82, "48": [73, 76, 77, 78, 81, 82, 83, 84, 85, 86, 95], "480": [81, 82, 86], "4801": 84, "48028": 81, "48053": 83, "48077": 81, "48078": 81, "48084": 81, "481": [73, 82, 84, 86], "4812": 82, "48132": 81, "48186": 81, "4819": 83, "482": [76, 82, 86], "4822": 86, "483": [73, 82, 86], "4831": 84, "4836": 81, "4838": [81, 82], "484": [82, 86], "4849": 74, "485": [75, 78, 82, 86], "48533": 86, "4856": 73, "48569": 81, "486": [73, 82, 86, 95], "48625": 83, "48667": 81, "487": [81, 82, 84, 85, 86], "487536": 85, "48772": 82, "488": [82, 86], "48806": 85, "4886": 86, "4889": 73, "489": [82, 84, 86], "48906": 81, "48975": 82, "49": [73, 81, 82, 83, 84, 85, 86, 88, 95], "490": [73, 76, 82, 86], "491": [73, 82, 86, 95], "49115": 81, "49118": 86, "4917": [74, 81], "49195": 82, "492": [73, 81, 82, 86], "49246": 86, "4927": 82, "493": [73, 82, 86], "49387": 83, "494": [81, 82, 83, 85, 86], "4940": 82, "4945": 81, "4949": 82, "495": [73, 82, 84, 86], "495976": 3, "496": [81, 82, 84, 86], "49664": 82, "497": [82, 86], "498": [45, 46, 47, 50, 51, 82, 85, 86], "49883": 82, "498876": 85, "499": [82, 85, 86], "49935": 82, "49941": 82, "499425": 85, "49961": 82, "4_1": 84, "4a": 99, "4b": 99, "5": [0, 1, 2, 3, 6, 11, 21, 33, 40, 41, 44, 45, 46, 47, 48, 50, 51, 53, 54, 58, 59, 60, 63, 66, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 97, 99], "50": [1, 16, 40, 41, 43, 50, 51, 53, 54, 55, 58, 72, 73, 78, 81, 82, 83, 84, 85, 86], "500": [53, 59, 60, 73, 75, 82, 86], "5000": [40, 72, 73], "50000": [63, 73], "500054": 85, "50058": 81, "501": [82, 84, 86], "50131": 83, "50161": 83, "502": [82, 83, 84, 86], "50240": 86, "50245": 86, "50270": 86, "503": [73, 79, 82, 84, 86], "504": [75, 82, 84, 86], "50436": 81, "5046": 85, "505": [73, 82, 84, 86], "5056": 86, "50568": 81, "506": [73, 75, 82, 84, 86, 95], "50628": 82, "50635": 81, "5064": 83, "50654": 81, "50699": 83, "507": [73, 82, 84, 86], "50746": 81, "5079": [82, 86], "508": [76, 82, 84, 85, 86], "50846": 83, "509": [82, 86], "50948": 78, "51": [0, 73, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86], "510": [82, 86], "5100": 81, "51078": 83, "511": [82, 86], "51129": 81, "5117": 86, "512": [82, 86], "5123": 81, "51263": 81, "513": [73, 82, 86], "51306": 81, "51318": 82, "514": [73, 75, 82, 86], "51405": 88, "5144": 81, "51458": 82, "5147": 85, "515": [75, 82, 86], "51574": 81, "516": [82, 86], "51628": 83, "517": [82, 85, 86], "51747": 74, "51758": 83, "5179": 82, "51795": 82, "518": [75, 82, 84, 86, 95], "5181": 83, "51811": 82, "51821": 82, "51832": 81, "51841": 82, "51862": 82, "51878": 82, "519": [73, 76, 78, 81, 82, 86], "51956": 82, "5198": 85, "52": [40, 73, 78, 81, 82, 83, 84, 85, 86], "520": [73, 82, 86], "52026": 82, "52074": 82, "521": [78, 81, 82, 86], "52119": 82, "52160": 84, "52161": 84, "52191": 82, "522": [76, 78, 82, 86], "52200": 82, "52237": 84, "52255": 83, "52264": 82, "5227": 83, "523": [73, 82, 84, 86], "52311": 82, "52345": 82, "52354": 82, "5239": 86, "52397": 82, "524": [82, 86], "52445": 82, "5247": 82, "525": [76, 81, 82, 86, 95], "52554": 82, "52573": 83, "52596": 82, "526": [82, 85, 86], "52644": 82, "52645": 84, "52646": 84, "52671": 81, "52687": 82, "527": [76, 82, 84, 86], "52701": 82, "52714": 82, "52727": 84, "52734": 82, "52761": 82, "52769": 82, "52795": 81, "52798": 83, "528": [74, 76, 82, 86], "52804": 82, "5281": 82, "52842": 82, "52856": 81, "52887": 82, "529": [73, 85, 86], "5293": 82, "52974": 82, "53": [78, 79, 81, 82, 83, 84, 85, 86], "530": [82, 84, 86, 88], "53061": 82, "531": [82, 86], "5312": 86, "53176": 82, "532": [82, 86], "53203": 83, "53263": 82, "533": [74, 84, 86], "53322": 81, "534": [73, 76, 81, 86], "53407": 82, "5343": 86, "535": [75, 82, 86], "53596470096178": 3, "536": [82, 86], "5362": 81, "53633": 82, "5364": 86, "53669": 81, "537": [73, 86], "53738": 81, "538": [73, 82, 86], "53877": [40, 84], "539": [82, 85, 86], "53916": 81, "53938": 81, "53976": 84, "53e": 86, "54": [73, 74, 81, 82, 83, 84, 85, 86], "540": [74, 79, 86], "54045": 84, "541": [84, 86], "54143": 83, "5416": 81, "542": [82, 86], "54278": 83, "543": [2, 82, 86], "54359": 86, "54367": [40, 84], "54372": 84, "544": [73, 86], "54461": [40, 84], "54465": 83, "5448": 81, "545": [86, 95], "5450": 81, "54511": 84, "54522": 84, "54531": 83, "546": 86, "5463": 84, "54689": 84, "5469": 86, "547": 86, "5470": 81, "54736": 83, "5477": [82, 84], "548": [82, 86], "5481": 84, "54845": [40, 84], "5485": 81, "54879": 84, "549": [76, 81, 82, 86], "5491": 83, "54944": 81, "54992": 81, "55": [2, 73, 74, 78, 81, 82, 83, 85, 86, 88], "550": [73, 82, 86], "5500": 38, "55006": 83, "55025": 83, "55061": 84, "551": [82, 84, 86], "5513": 86, "55131": [86, 87], "5515": 86, "5519": 86, "552": [82, 86], "5520": 86, "55212": 81, "55289": 81, "553": 86, "55316": 82, "55331": 83, "5535": 84, "55378": 83, "554": [73, 86], "55413": 81, "555": [82, 86], "55579": 82, "556": [73, 86], "5563": 81, "557": [2, 81, 86], "5578": 86, "558": [82, 86, 95], "5583": 86, "5585": 86, "5588": 86, "55891": 83, "559": [82, 86], "5591": 86, "5595": 85, "56": [73, 75, 77, 78, 81, 82, 83, 84, 86], "560": [73, 84, 85, 86], "5604": 86, "561": [82, 85, 86], "56107": 82, "56122": 81, "56197": [86, 87], "562": [74, 82, 83, 86], "56215": 49, "5626": 86, "562e": 81, "563": 86, "564": [78, 84, 86], "5649": [82, 83], "565": [81, 86], "56529": 83, "5653": 82, "5659": 81, "566": [82, 83, 84, 86], "56625": 81, "567": [82, 86], "56722": 78, "56749": 83, "56765": 82, "5677": 82, "56777": 82, "56787": 82, "5679": 81, "56798": 82, "568": 86, "56809": 82, "56826": 82, "56838": 82, "56849": 82, "5685": 81, "56899": 82, "569": [73, 85, 86], "5690": 81, "56917": 81, "56933": 82, "56975": 82, "57": [73, 74, 78, 79, 81, 82, 83, 84, 85, 86], "570": [82, 86], "57026": 81, "57059": 82, "57076": 81, "571": [73, 82, 84, 86], "5715": 82, "57195": 81, "572": [73, 86], "57234": 81, "5725": 82, "573": 86, "5736": 82, "57376": 83, "574": 86, "57424": 84, "575": 86, "576": [81, 82, 86], "577": [73, 82, 86], "57758": 84, "57792": 84, "578": [82, 86], "57819": 81, "5782": 83, "5789": 88, "579": [81, 82, 85, 86], "57988": 82, "58": [73, 81, 82, 83, 84, 85, 86, 88], "580": 86, "5801": [83, 85], "58041": 83, "581": [86, 87], "58133": 82, "5819": [], "582": [84, 86], "58232": 84, "58238": 83, "583": 86, "58327e": 82, "584": [73, 86], "585": 86, "58521": 83, "586": [82, 86], "5869": 81, "587": [82, 86], "5875": [54, 81], "588": [76, 85, 86], "589": [82, 85, 86], "59": [74, 81, 82, 84, 85, 86, 88], "590": 86, "59074": 83, "591": [82, 86], "59145": 83, "5919306617286774e": 3, "592": [81, 82, 86], "5925": 35, "593": [73, 86], "59331": 81, "594": [84, 86], "595": [82, 86], "59561": 82, "596": [82, 86], "597": 86, "59713": 83, "5975": [40, 84], "5976": 86, "598": [73, 86], "599": [76, 82, 86], "5991": 81, "5992": 81, "5993": 86, "5994": [], "5e": [38, 88], "5e5": 63, "5i3l": 77, "5rel": 82, "5th": 77, "6": [1, 2, 3, 15, 18, 38, 40, 44, 45, 47, 51, 53, 59, 60, 63, 68, 69, 72, 73, 74, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96, 99], "60": [1, 40, 63, 73, 75, 78, 79, 82, 84, 85, 86, 96], "600": [53, 84, 86], "600614003857873": 3, "6009": 86, "601": [78, 82, 84, 86], "6013": 74, "602": [73, 76, 78, 82, 86], "6022": 82, "603": 86, "60375": 83, "604": 86, "605": [73, 86], "606": 86, "6069": 83, "607": [73, 78, 82, 86], "608": [73, 86], "60805": 81, "609": [81, 86], "60951": 83, "60967": 81, "61": [73, 74, 81, 82, 84, 85, 86], "610": [82, 86], "611": [81, 86], "61143": 82, "6115": 83, "612": [73, 86], "6121": 86, "613": [82, 86], "614": [84, 86], "615": 86, "616": [76, 83, 84, 86], "617": [84, 86], "61707": 81, "6172": [81, 82], "6178": 81, "618": [82, 86], "6180": 85, "61803": 82, "6182": 85, "6185": 85, "6186": 85, "619": [76, 86], "6192": 82, "62": [73, 78, 82, 84, 86, 95], "620": 86, "621": 86, "62128": 83, "621e": 86, "622": [73, 76, 81, 82, 86], "62208": 82, "622571": 74, "6227": 85, "6228": 85, "6229": 82, "623": [82, 85, 86], "624": [81, 82, 86], "6249": 82, "625": [76, 86], "6250": 84, "6254": 88, "626": [76, 86, 95], "62669": 78, "627": [82, 86], "627963": 74, "628": [73, 82, 84, 86], "629": [73, 82, 86], "62916": 83, "63": [73, 74, 81, 82, 84, 85, 86], "630": [82, 86], "63002": 83, "6304": 84, "631": [73, 74, 76, 85, 86], "6314": 0, "6317": 82, "632": 86, "6321": 81, "6328": 81, "633": [74, 86], "6334": 84, "634": [81, 82, 84, 86], "6341": 84, "635": [73, 86], "636": [73, 86], "637": [73, 74, 76, 83, 86], "6375": 81, "6376": 84, "6379": 82, "638": [82, 86, 95], "63827": 83, "639": [76, 86], "6395": 84, "64": [73, 74, 75, 78, 81, 82, 84, 86, 96], "640": [82, 86], "6405": 84, "6408": 83, "641": [83, 86], "6416": 84, "642": [73, 86], "6425": 86, "64259": 83, "643": [74, 86, 87], "6433": 81, "6435": 95, "644": [82, 86], "64495": 83, "645": 86, "6455": 82, "646": 86, "6461": 81, "64632": 83, "64633": 83, "647": [73, 86], "6476": 81, "648": [73, 82, 86], "64811": 82, "648603": 73, "64887": 83, "649": [82, 84, 86], "6490": 86, "6495": 74, "64e": [], "65": [73, 78, 81, 82, 84, 85, 86], "650": [73, 83, 86], "651": [85, 86], "6513": [], "652": [83, 86], "65283": 81, "653": 86, "654": [81, 84, 86], "655": 86, "6552": 78, "656": [81, 86], "6562": 82, "6569": 88, "65693038892429": 3, "657": [74, 84, 86], "657129890916668": 3, "65721": 83, "65796": 81, "658": [81, 85, 86], "6589": 81, "659": [82, 85, 86], "6591": 81, "659883": 86, "66": [78, 81, 82, 84, 85, 86, 87, 95], "660": [82, 86], "661": [82, 86], "662": [82, 86], "663": [73, 86], "664": 86, "6643": 82, "665": 86, "6651": 83, "666": [73, 76, 86], "667": [82, 86], "668": 86, "669": [82, 84, 86], "669628": 86, "67": [40, 73, 78, 82, 84, 85, 86], "670": [73, 86], "6705": 82, "671": [84, 86], "6714": 85, "67141": 74, "672": [73, 82, 86], "67233": 81, "673": [73, 82, 86], "6737": 82, "674": [76, 86], "6749": 88, "675": [81, 82, 86], "67537": 81, "676": [76, 86], "67612": 81, "6762": [], "677": 86, "678": 86, "678373": 77, "678570": 78, "678646": 78, "678848": 77, "67885": 81, "67891": 86, "678914": 77, "679": [73, 86], "679306": 78, "679516": 78, "679612": 78, "68": [40, 49, 73, 75, 78, 82, 84, 85, 86], "680": [81, 86], "6804": 81, "6806": 81, "681": [82, 86], "68191": 83, "68198": 83, "682": [78, 86], "683": 86, "684": [82, 86], "6841": 82, "685": [82, 86], "686": 86, "687": 86, "6874": 85, "6875": 85, "6878": 81, "688": [81, 82, 86], "6880": 81, "6885": 78, "689": [84, 86], "68902": 82, "69": [40, 73, 81, 82, 84, 85, 86, 87, 95], "690": 86, "69007": 83, "6902": 81, "691": 86, "6912": 86, "69191": 81, "692": [82, 86], "693": [83, 86], "694": 86, "695": [82, 86], "6956": 84, "6959": 86, "696": [73, 86], "6964": 84, "6965": 81, "6969": 81, "697": [81, 82, 86], "69743": 81, "698": 86, "6983": 88, "699": [73, 76, 82, 86], "7": [2, 3, 37, 40, 45, 46, 47, 48, 50, 51, 73, 74, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96], "70": [73, 74, 76, 82, 84, 85, 86, 95], "700": [1, 79, 82, 86], "7000": 11, "7002": [], "70048": 83, "701": [81, 86], "702": [82, 84, 86], "70272": 83, "703": [82, 86, 87], "704": [86, 87], "70452": 81, "705": [76, 79, 82, 86], "70558": [], "70559": 86, "7057": 83, "706": [73, 82, 86], "7062494437063": 3, "706694": 86, "707": [82, 86], "7070": 74, "7072": 81, "7075": 81, "70752": 81, "708": [73, 82, 86], "70801": 79, "7085": 83, "709": [85, 86], "71": [40, 73, 74, 79, 81, 82, 83, 84, 85, 86, 95], "710": [73, 86], "711": [82, 86], "712": [82, 86], "713": [82, 86], "71331": 83, "714": [73, 86], "7142": 83, "715": [73, 82, 86], "7159": [], "716": [82, 84, 86], "717": [82, 84, 86], "71785": 81, "718": [73, 86], "719": [73, 84, 86], "72": [18, 40, 69, 73, 74, 79, 81, 82, 83, 84, 86, 87, 95], "720": 86, "721": [82, 86], "72162": 81, "722": [73, 82], "723": 86, "7235": 81, "724": 76, "7241": 81, "72428": 81, "72438": 83, "725": [82, 84, 85], "726": 86, "7267": 81, "727": [82, 84, 86], "72705": 81, "728": [76, 82], "7289": 81, "729": 81, "7293": 81, "72e": 84, "73": [73, 74, 81, 82, 83, 84, 86], "730": [82, 86], "731": [82, 86], "73284": 81, "733": [86, 87], "734": [82, 84], "735": [73, 82, 86], "736": [73, 77, 82, 84, 86], "737": 82, "73719": 83, "738": 82, "738e": 82, "739": [73, 77], "74": [40, 74, 75, 78, 79, 81, 82, 84, 86, 95], "740": [82, 85], "74028": 86, "741": 73, "7410": 85, "742": [83, 84], "7429": 88, "743": 82, "7432": 84, "74323": 84, "744": 73, "745": 81, "74578": 83, "746": [73, 74, 78, 82, 86], "747": 84, "7478": [40, 84], "7479": 86, "748": [82, 86], "749": [76, 84], "7490": 78, "74952": 84, "75": [12, 45, 54, 73, 78, 79, 81, 82, 84, 85, 86, 95], "750": 84, "75074": 84, "75085": 84, "751": [73, 82], "752": [72, 73, 84, 95], "7521": 81, "75377": 84, "754": 84, "75406": 84, "75442": 84, "75458": 83, "755": [73, 82], "75607": [40, 84], "7571": 82, "758": [76, 81, 82], "759": 82, "7599": 81, "76": [11, 73, 74, 78, 79, 81, 82, 84, 85, 86, 95], "760": [73, 82, 85], "7603": 74, "76079": [40, 84], "7608": 81, "761": 73, "76136": 83, "762": 82, "7620": 82, "763": [73, 85], "7630": 85, "7632": 85, "7634": [], "764": 82, "7644": 81, "76468": [40, 84], "7648": 86, "765": 82, "76579": 84, "766": 82, "7676": 82, "769": [72, 73, 84, 95], "77": [73, 74, 75, 78, 79, 81, 82, 84, 85, 86, 87], "770": 76, "771": 81, "772524827250213e": 3, "773": [74, 76, 84], "774": 82, "7747": 81, "7749": 81, "775": [73, 82, 84, 85], "777": [73, 82], "77775": 83, "778": 81, "778243": 74, "77983": [40, 84], "78": [73, 74, 76, 77, 79, 81, 82, 83, 84, 85, 86, 95], "780": 82, "781": 84, "7811": 82, "78117": 84, "7812": 85, "7813": 85, "781e": 86, "782563": 74, "783": 82, "78346": 79, "7837": 82, "7844": 82, "785": 82, "7854": 82, "786": [81, 82, 86], "7863": 82, "787": 74, "7872": 82, "78839": 83, "79": [1, 53, 73, 76, 79, 81, 82, 83, 84, 85, 86], "790": [73, 86], "79025": 73, "791": 73, "79118": 83, "7919": 81, "792": [84, 85], "793": 76, "79369": 84, "794": [73, 82, 85, 86], "79464": [], "79465": 86, "79472": [], "79473": 86, "79481": [], "79482": 86, "79493": [], "79494": 86, "795": 82, "79501": [], "79502": 86, "79527": [], "79528": 86, "79544": [], "79545": 86, "796": 73, "79619": [], "7962": 86, "79677": 86, "797": 82, "7975": 82, "798": 73, "799": [73, 82], "7beq": 74, "7e": 88, "8": [1, 2, 11, 22, 40, 44, 47, 49, 53, 63, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95], "80": [12, 33, 40, 73, 78, 79, 81, 82, 84, 85, 86, 87], "800": [73, 82], "80027": 83, "80046": [], "80047": 86, "801": 76, "801406_1": 73, "801574_1": 73, "802": [73, 81, 82], "802003_1": 73, "80208": 81, "803": 82, "804": 82, "80437": 83, "805": [73, 82], "806": [82, 85], "8072": 76, "808": [73, 82, 86], "809": 82, "81": [73, 74, 79, 81, 82, 84, 85, 86], "81007": 86, "810542_1": 73, "811": [74, 82, 85], "812": [73, 82], "8125": [48, 82], "813": 82, "81377": 83, "814": [74, 82], "81495": 81, "815": 84, "81509": [], "8151": 86, "81589": 83, "816": [73, 82, 84], "817": [73, 82], "8170": 82, "818": [84, 85], "81814": 83, "8183": 82, "8184": 82, "819": [82, 84], "82": [18, 69, 73, 78, 79, 81, 82, 84, 85, 86, 95], "820": 84, "821": 82, "82146": 83, "822": [82, 86], "823": 76, "8234": 86, "824": [76, 84], "8256": 86, "826": 82, "8264": 83, "827": 73, "8270": 86, "828": 82, "82846": 81, "829": 82, "8298": [], "82981": 86, "82988": [], "82989": 86, "82e": 84, "83": [73, 78, 82, 84, 85, 86], "830": 74, "831": [73, 76, 81, 82, 84], "83106": [83, 86], "83161": 86, "832": 84, "8325": [40, 84], "83299": 86, "833": [75, 82, 85], "8339": 83, "834": [81, 84, 86], "835": 82, "8353": 81, "8365": 73, "8366": [], "83667": [], "83668": 86, "837": 82, "838": 84, "839": [77, 83], "84": [73, 74, 81, 82, 84, 85, 86, 87], "840": 85, "8417": 86, "842": [73, 78, 82], "8429": 86, "843": [76, 86], "8436": 82, "845": [84, 85], "846": [82, 84], "84699": 82, "847": 84, "848": 82, "849": 82, "84910": 73, "8498": 73, "85": [73, 75, 76, 78, 79, 81, 82, 84, 85, 86, 95, 96], "8507": 76, "851": [73, 82], "852": 82, "853": 82, "8531": 73, "85351": 81, "854": [76, 82], "8541": 86, "85448": 81, "8545": [40, 84], "855": 82, "8559": 83, "856": [73, 82], "857": 82, "8570": 82, "85708": 81, "8572": 82, "8575": 82, "858": 82, "859": 82, "86": [73, 82, 84, 85, 86], "860": 82, "861": 82, "86348": 83, "8636": 84, "864": [76, 84], "865": [73, 82, 84], "8650": 76, "86526": 81, "8654": 84, "866": [73, 76, 84], "867": 82, "8672": 82, "868": 82, "869": 73, "8693": 82, "86945": 83, "86962": 82, "87": [73, 76, 78, 81, 82, 83, 84, 85, 86], "870": 73, "871": [82, 83], "872": 84, "873": [73, 82], "87496": 83, "875": 82, "876": 73, "877": [82, 95], "8777": 82, "878": [82, 84], "879": [73, 82], "88": [73, 74, 78, 81, 82, 84, 85, 86], "880": 82, "8800": 81, "8807": 83, "881": [73, 82, 85, 86], "8813": 82, "883": [84, 86], "884": 84, "885": [73, 84], "88594": 86, "88595": [], "886": [74, 78, 82, 83, 84], "8863": 85, "887": [82, 87], "8871": 85, "8873": 82, "8876": [], "888": [73, 82], "889": [82, 84], "8896": [40, 84], "89": [74, 75, 77, 78, 79, 82, 83, 85, 86, 87], "890": [73, 86], "891": [73, 82, 86], "892": 76, "893": [82, 85, 86], "894": [82, 95], "895": 85, "8951": 82, "8952": 81, "8957": 82, "896": 82, "89652": 86, "897": [73, 82, 84], "8970": 82, "898": [76, 82], "8986": 81, "8996": 82, "8997": 82, "8e": [40, 84], "8m3": 83, "9": [3, 11, 40, 45, 52, 53, 73, 74, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95], "90": [1, 40, 45, 46, 47, 50, 51, 53, 54, 73, 74, 75, 76, 77, 78, 79, 81, 82, 84, 85, 86, 87, 88, 95, 96], "900": [73, 82], "9000": 82, "901": [82, 86], "9013": 85, "9018": 81, "902": 82, "903": [81, 84], "9033": 82, "9039": 82, "904": [82, 85], "904199434387693e": 3, "90458": 83, "905": [73, 82], "9054": 82, "906": [73, 82, 84, 86], "907": [82, 84, 86], "90710": 86, "908": [73, 82], "90807": 83, "90889": 86, "909": [82, 86, 87], "91": [78, 82, 84, 85, 86], "910": [73, 82, 84], "91089": 86, "911": [73, 82], "91153": 86, "912": [82, 84, 85], "91203": 86, "91236": 83, "9124": 82, "9126": 82, "91362": 81, "914": [73, 82, 86], "915": 73, "9155": 76, "91555": [], "91556": 86, "91579": 83, "91595": [], "91596": 86, "916": [38, 82], "917": [38, 73, 82], "918": [82, 84], "91895": 86, "919": [74, 82, 86], "91913": 83, "9195": 82, "92": [49, 73, 74, 76, 79, 81, 82, 84, 85, 86, 95], "920": [73, 82, 84], "92029": 86, "92093": 86, "921": [73, 82], "9212": 81, "9213": 81, "92165": 86, "92194": 81, "922": [82, 84, 86], "9222": [40, 84], "92296": 86, "923": 82, "9239": 86, "924": 83, "9244": 85, "9245": 85, "925": [84, 86], "9253": 86, "92639": 86, "9265": 82, "92656": 86, "927": [81, 82, 84, 86], "928": [82, 84], "9281": 74, "9283": [], "929": [82, 84, 86], "92940": 86, "93": [76, 78, 81, 82, 84, 85, 86, 88, 95], "930": 81, "9301": 86, "93047": 86, "93092": 86, "931": [73, 76], "93126": 86, "93138": 86, "932": [40, 73, 82, 84], "93248": 86, "933": [40, 82, 84], "93302": 86, "93340": 86, "93360": 86, "934": [40, 82, 84], "93419": 86, "935": 73, "9351": 82, "9352": 83, "93595": 86, "936": [40, 74, 82, 84], "937": [73, 82, 84, 85, 86], "93703": 86, "93709": 86, "93712": 86, "93742": 86, "93749": 86, "93816": 86, "93838": 86, "9385": 81, "9386": 81, "93862": 86, "93867": 86, "93870": 86, "93872": 86, "93886": 86, "93890": 86, "939": [73, 83, 86], "93959": 86, "93960": 86, "93970": 86, "94": [73, 74, 76, 81, 82, 84, 85, 86, 87, 96], "940": 82, "94017": 86, "94031": 86, "94057": 86, "94063": 86, "94065": 86, "94077": 86, "94089": 86, "94097": 86, "941": [73, 82, 84], "94101": 86, "94103": 86, "9414": 82, "94166": 86, "94172": 82, "94173": 86, "94187": 83, "94188": 86, "94194": 86, "942": [73, 76, 82, 84], "94215": 86, "94275": 86, "943": [73, 82, 84, 85], "94373": 86, "944": [82, 83, 84], "945": [82, 84], "9452": 84, "946": [76, 82], "947": [73, 76, 82, 84], "948": [82, 84, 86], "94809": 81, "949": 84, "95": [1, 37, 40, 45, 54, 63, 69, 73, 76, 81, 82, 84, 85, 86], "950": [74, 82], "95027": 81, "9504": 81, "95064": 82, "95067": 82, "95093": 82, "951": [73, 75, 82, 84], "95156": 82, "952": [75, 82, 84, 86], "9522": 81, "95249": 82, "953": [40, 73, 74, 82, 84], "954": [73, 78, 82], "95430": 86, "95431": 86, "95432": 86, "95478": 82, "955": 82, "956": [73, 75, 85], "9560": 86, "9567": 81, "95684": [86, 87], "95685": [], "95698": [], "95699": 86, "957": [73, 84], "9574": [], "958": [82, 84], "959": [81, 82, 85, 86], "9593": 81, "95999": 82, "96": [40, 73, 76, 78, 81, 82, 84, 85, 86, 88, 96], "960": [73, 75], "961": [73, 82, 84, 86], "9614": 86, "962": [84, 85], "963": [82, 84], "964": [73, 82, 86], "9645": 81, "965": 73, "965028": 86, "96574": 86, "966": [73, 82], "96614": 82, "967": 84, "9672": 86, "9673": 86, "968": [73, 84, 86], "96848": 83, "969": [82, 84, 85], "97": [40, 73, 74, 76, 78, 79, 81, 82, 84, 85, 86, 87, 95], "970": 73, "971": [73, 81, 82, 83, 84], "9712": 81, "9716": 86, "972": [82, 86], "97204": 83, "9721": 95, "9722": 86, "9725": 86, "97255": 82, "972795822746061": 3, "9728": 86, "973": [76, 82, 85], "97306": 83, "9731": 86, "974": [74, 81, 84], "97476": 83, "975": [41, 51, 53, 54, 58, 59, 60, 69, 73, 81, 84], "9752": 86, "976": [82, 86], "97625": 79, "9765": 78, "977": [81, 82, 84, 85], "9778": 85, "978": [0, 82, 84, 85, 86], "9783": 86, "979": [73, 82, 85, 86], "97949": 85, "979493": 84, "9795": 3, "98": [73, 74, 75, 76, 78, 79, 81, 82, 84, 85, 86, 87], "980": [73, 82], "9802": 82, "98056": 83, "981": [82, 83, 85], "9810": 86, "9811": [], "9812": [], "9814": 85, "9815": [], "982": [84, 85], "983": [73, 82, 84, 85], "9833": 82, "98356": 86, "9838": 82, "984": [81, 82, 86], "98416": 78, "98469": 81, "985": [86, 88], "9850": 85, "986": [73, 84, 85], "987": [82, 83, 84, 86], "988": [73, 82, 85, 86], "9881": 86, "989": [73, 82], "9895": 82, "9899": 82, "99": [44, 69, 73, 74, 76, 77, 78, 79, 82, 83, 84, 85, 86, 87, 96], "990": [73, 82, 84], "9907": 82, "991": [73, 82, 84, 86, 88], "9914": 78, "99161": 82, "992": [73, 76, 84, 85], "99298": 82, "993": [73, 74, 76, 82, 84, 85], "9931": 82, "99366": 82, "9938": 86, "994": [73, 76, 84], "99429": 82, "9943": 79, "9945": 82, "99453": 82, "9949": 86, "995": [73, 76, 82, 85, 86], "996": [73, 76, 78, 82, 83, 84, 86], "9961": 86, "997": [76, 82, 84, 85, 86], "997300": [41, 51, 54, 58], "998": [73, 79, 82, 84, 86, 87], "9982": 86, "99873": 86, "99874": 84, "99889": 86, "99893": 86, "99897": 86, "99898": 84, "99899": 86, "999": [3, 21, 82, 84, 86, 87], "99904": 84, "99909": 84, "99914": 84, "99916": 84, "9992": 84, "99921": 84, "99926": 84, "99952334925477": 3, "999803": 75, "9999": [44, 84], "999913": 86, "999939": 86, "9999551354884303": 3, "9999691721195861": 3, "999994": 82, "999997269169901": 3, "999998": 82, "999999": 44, "9999999": 44, "9m": 76, "9m56": 83, "A": [0, 1, 2, 3, 4, 6, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 30, 31, 33, 35, 40, 43, 44, 47, 49, 52, 53, 54, 59, 60, 61, 63, 70, 72, 73, 74, 75, 78, 80, 81, 82, 84, 85, 86, 88, 92, 93, 94, 95, 96, 97], "AND": [33, 92], "AS": [92, 95], "AT": 95, "And": 88, "As": [1, 2, 4, 7, 35, 40, 44, 47, 74, 78, 79, 81, 82, 83, 84, 85, 86, 87, 96, 97], "At": [0, 2, 7, 53, 59, 60, 74, 77, 78, 81, 82, 83, 86, 87, 88, 97], "BE": 92, "BUT": 92, "BY": 92, "But": [74, 84], "By": [1, 2, 7, 34, 52, 53, 55, 59, 60, 61, 63, 66, 68, 70, 74, 76, 81, 82, 83, 84, 85, 86, 87, 88], "FOR": 92, "For": [1, 2, 7, 9, 11, 14, 15, 38, 41, 42, 44, 47, 48, 51, 52, 53, 54, 55, 58, 59, 60, 72, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 88, 90, 91, 96], "IF": 92, "IN": 92, "If": [1, 4, 7, 9, 11, 14, 15, 16, 18, 22, 24, 33, 34, 35, 38, 40, 43, 44, 46, 47, 48, 50, 52, 53, 54, 59, 60, 63, 64, 66, 68, 69, 70, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 96], "In": [0, 1, 2, 4, 7, 11, 14, 15, 21, 23, 40, 47, 52, 53, 54, 59, 60, 61, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 97], "It": [2, 3, 11, 14, 35, 37, 40, 41, 50, 53, 54, 59, 60, 63, 71, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87], "Its": [2, 36], "NO": 92, "NOT": [18, 92], "Near": 74, "No": [38, 40, 82, 83, 84, 85, 86, 96], "Not": [38, 45, 51, 52, 53, 59, 60], "OF": 92, "ON": 92, "OR": 92, "Of": 2, "On": [2, 49, 74, 75, 77, 83, 87], "One": [1, 38, 74, 75, 76, 78, 83], "Or": [71, 91], "SUCH": 92, "Such": [2, 88], "THE": 92, "TO": 92, "That": [2, 14, 74, 83], "The": [0, 1, 3, 4, 6, 7, 9, 11, 12, 14, 15, 16, 17, 18, 22, 23, 24, 25, 26, 29, 30, 31, 33, 35, 36, 38, 40, 41, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 57, 58, 59, 60, 61, 62, 63, 64, 66, 69, 70, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 91, 93, 94, 95, 96, 97, 98], "Then": [9, 14, 53, 59, 60, 75, 76, 82, 86, 87, 91, 96], "There": [1, 2, 7, 9, 74, 75, 76, 77, 78, 81, 82, 83, 86, 87, 90, 97], "These": [1, 2, 3, 4, 14, 15, 33, 38, 48, 53, 60, 63, 74, 75, 76, 78, 80, 82, 83, 84, 86, 87, 96], "To": [0, 1, 2, 4, 7, 11, 14, 47, 49, 74, 75, 77, 78, 82, 83, 84, 85, 86, 87, 91, 93, 96, 97], "Will": 1, "With": [14, 35, 73, 74, 75, 76, 81, 83], "_": [2, 22, 35], "_0": 35, "_1": [2, 35], "_2": 2, "_3": 2, "__cxx11": [22, 23, 24, 25, 26], "__future__": [4, 6], "__id__": 3, "__init__": [4, 6, 10, 11, 12, 14, 15, 16, 17, 18, 22, 23, 24, 25, 26, 30, 31, 33], "__main__": [6, 83], "__name__": [6, 83], "_compon": 4, "_detector": 26, "_do_outlier_reject": 15, "_goniomet": 4, "_goniometer_factori": 4, "_i": [2, 35], "_n": 2, "_object": [10, 12, 14, 22, 23, 24, 25, 26], "_outlier_indic": 15, "_processor": 12, "_processorrot": 12, "_reindex": 40, "_rmsds_core": 14, "_src_path_root": 4, "_\u03ba": 2, "_\u03c6": 2, "_\u03c9": 2, "a1": [18, 82, 86], "a2": [7, 18, 96], "a222": 77, "aaron": 0, "ab": [2, 82, 84, 86], "abandon": 79, "abbei": 74, "abc": 2, "abil": 42, "abl": [40, 82, 86, 87], "abnorm": 84, "about": [2, 4, 7, 14, 15, 23, 25, 47, 48, 57, 62, 74, 76, 78, 81, 82, 83, 84, 85, 86, 87, 98], "abov": [1, 4, 9, 37, 38, 40, 41, 44, 47, 51, 54, 58, 63, 69, 70, 73, 74, 76, 82, 84, 86, 87, 88, 92], "abraham": [75, 95], "abruptli": 83, "absenc": [35, 69, 72, 79, 82, 84, 86, 88], "absent": [18, 40, 68, 72, 82, 84, 85, 86], "absolut": [1, 18, 30, 44, 53, 59, 60, 72, 83, 84], "absolute_angle_toler": [11, 18, 40, 53, 69, 72], "absolute_cutoff": [14, 53, 59, 60], "absolute_import": 4, "absolute_num_interv": [53, 59, 60, 73, 75], "absolute_toler": 33, "absorb": 63, "absorpt": [1, 15, 35, 54, 63, 72, 82, 84, 86, 87, 88], "absorption_correct": [1, 54, 63], "absorption_level": [1, 63, 72, 88], "abspath": 83, "abstract": [0, 2, 14, 15], "ac": [2, 91, 95], "ac02": [0, 90], "acad": 95, "accept": [2, 7, 14, 47, 50, 51, 53, 72, 73, 82, 84, 86, 87], "access": [1, 9, 14, 21, 48, 81, 83, 87, 90], "accessor": 14, "accord": [11, 14, 18, 42, 46, 47, 76], "accordingli": 77, "account": [1, 2, 35, 47, 50, 51, 82, 84, 86, 87, 88], "accumul": [0, 12, 18], "accur": [14, 47, 50, 51, 73, 78, 83, 88, 95, 97], "accuraci": [53, 59, 60], "acentr": 84, "achiev": [7, 14, 35, 53, 56, 59, 60, 81, 88], "acronym": 44, "across": [0, 1, 43, 53, 59, 60, 63, 72, 74, 75, 82, 84, 88, 96], "act": [47, 51, 66], "acta": [0, 2, 11, 18, 40, 69, 72, 75, 79, 84, 95], "action": [53, 59, 60], "actual": [2, 14, 15, 73, 76, 81, 83, 86], "ad": [33, 44, 59, 70, 73, 74, 76, 81, 82, 86, 94], "ada": 94, "adam": [0, 2, 11, 95], "adapt": [14, 75, 94], "adaptlbfg": [14, 19], "adaptlstbx": [14, 19], "add": [4, 9, 10, 12, 14, 15, 29, 33, 44, 47, 53, 73, 76, 82, 86, 87, 91, 96], "add_batch_list": [32, 33], "add_column": 14, "add_constant_to_diagon": 14, "add_cryst": 33, "add_dataset": 33, "add_empty_dataset": 33, "add_experi": 33, "add_group": 23, "add_panel": 23, "add_row": 14, "addit": [0, 1, 7, 14, 15, 26, 33, 41, 43, 44, 46, 47, 49, 53, 54, 59, 60, 63, 75, 81, 82, 84, 86, 87, 88, 94, 96], "addition": [14, 82, 84, 86], "additional_stat": 63, "address": [0, 78, 84, 97], "addsym": 73, "adher": [82, 86, 87], "adjust": [1, 73, 74, 75, 82, 84, 86, 87, 88], "adob": 71, "adopt": 2, "advanc": [16, 80, 82, 83, 86, 87, 89, 97], "advantag": [82, 83, 86, 87], "adventur": 97, "advic": [0, 77], "advis": [1, 92], "adxv": [81, 86], "ae": 95, "af": [10, 12, 14, 23, 24, 25, 26], "affect": [1, 42, 53, 59, 60, 72, 74, 75, 78, 82, 83, 84, 86, 87], "after": [0, 1, 14, 18, 35, 39, 44, 48, 53, 54, 59, 60, 61, 63, 66, 72, 73, 74, 75, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96], "ag": 85, "again": [73, 74, 78, 81, 82, 83, 85, 86, 87, 88, 93], "against": [11, 15, 18, 47, 59, 63, 70, 76, 77, 81, 82, 83, 86, 88, 89], "aggreg": 11, "agre": [1, 2, 76], "agreement": [53, 82, 84, 86, 87, 88], "aguila": 95, "ah": 95, "ahead": [26, 74, 77, 78, 83], "ai": 95, "aim": [1, 76, 88], "aimless": [1, 44, 75, 82, 84, 86, 87], "ak": 74, "al": [11, 64, 72, 79, 84], "albula": 81, "alcv": 83, "algorithm": [0, 1, 2, 4, 31, 32, 38, 40, 41, 42, 47, 50, 51, 53, 54, 58, 59, 60, 63, 71, 74, 78, 81, 82, 83, 84, 85, 86, 87, 90, 94, 95, 96, 98], "alguel": 83, "alia": [11, 12, 15, 33, 63], "align": [2, 11, 21, 23, 25, 34, 75, 76, 77, 78, 88], "align_cryst": 71, "all": [0, 1, 2, 3, 4, 7, 11, 14, 15, 18, 23, 24, 25, 26, 33, 35, 38, 40, 44, 45, 47, 48, 49, 51, 52, 53, 54, 59, 60, 62, 63, 64, 68, 69, 70, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 92, 96], "all_lau": 24, "all_rot": 24, "all_sequ": 24, "all_stil": 24, "all_tof": 24, "aller": [83, 95], "alloc": [22, 23, 24, 25, 26, 54], "allow": [1, 3, 11, 14, 16, 18, 23, 24, 34, 38, 44, 46, 48, 52, 53, 59, 60, 61, 63, 73, 74, 75, 76, 77, 81, 82, 83, 86, 87, 88, 90, 93, 94, 96], "allow_multiple_sequ": [52, 93], "allow_non": [35, 37, 38, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 58, 59, 60, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "almost": [53, 74, 76, 77, 82, 86], "along": [2, 11, 23, 33, 34, 40, 52, 53, 74, 75, 77, 81, 84], "alongisd": 63, "alongsid": [1, 73, 93], "alonso": 95, "alpha": [2, 25, 40, 53, 59, 60, 84, 88], "alpha_i": 35, "alreadi": [1, 4, 14, 16, 21, 23, 25, 26, 29, 53, 59, 60, 63, 72, 74, 76, 78, 82, 84, 86, 87, 88], "also": [1, 2, 3, 4, 7, 9, 11, 14, 15, 18, 21, 22, 23, 25, 26, 33, 37, 44, 48, 53, 59, 60, 61, 63, 66, 68, 70, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 91, 96], "alter": [45, 74, 76, 87], "altern": [1, 4, 7, 11, 52, 53, 59, 60, 61, 63, 66, 77, 79, 82], "although": [1, 38, 60, 73, 75, 77, 78, 81, 82, 83, 86, 87, 93], "altogeth": 18, "altruism": 0, "alun": [0, 97], "alwai": [1, 9, 47, 54, 77, 78, 83, 87], "ambigu": [18, 40, 61, 72, 76, 77, 84, 95], "ami": 0, "ammaar": 0, "amongst": [42, 83], "amount": [35, 41, 51, 54, 58, 63, 73, 84], "amplif": 84, "amplifi": 14, "amplitud": [33, 63, 77, 84, 85], "amyloid": 95, "an": [1, 2, 3, 4, 7, 9, 11, 14, 15, 16, 18, 21, 23, 24, 25, 26, 29, 30, 31, 33, 35, 37, 38, 40, 41, 42, 43, 44, 45, 46, 47, 48, 50, 51, 52, 53, 54, 58, 59, 60, 61, 62, 63, 64, 66, 67, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 90, 93, 95, 96, 97], "analogi": 2, "analys": [18, 37, 40, 52, 53, 59, 60, 74, 82, 83, 84, 86, 87, 90], "analyse_output": 81, "analysi": [14, 18, 37, 40, 49, 53, 56, 59, 60, 63, 69, 72, 77, 78, 80, 81, 85, 87, 88, 90, 95, 96, 97], "analysis_lev0": 81, "analysis_lev1": 81, "analytical_correct": 63, "analyz": 48, "anastassi": 97, "ancestor": 4, "andrei": 77, "andrew": [0, 40, 84, 97, 98], "ang": 53, "angl": [2, 6, 11, 18, 21, 23, 25, 33, 39, 40, 52, 53, 54, 60, 63, 68, 69, 70, 72, 73, 74, 76, 82, 84, 86, 87, 88], "angle_toler": 22, "angstrom": [1, 11, 41, 47, 50, 51, 53, 54, 58, 72, 77, 78, 81, 82, 83, 84, 86, 87], "angular": [2, 11, 18, 53, 59, 60, 81, 82, 86], "ani": [3, 7, 11, 14, 15, 18, 24, 33, 38, 40, 44, 47, 49, 52, 53, 59, 60, 61, 63, 66, 72, 74, 76, 77, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 92, 93], "anisotrop": [18, 84], "anisotropi": 84, "annlib": 33, "annlib_adaptbx": 33, "annot": 6, "annoy": 83, "anom_amplitud": 33, "anom_arrai": 33, "anom_multipl": 33, "anomal": [1, 33, 43, 63, 72, 74, 76, 79, 82, 84, 86, 87, 88], "anoth": [1, 53, 61, 74, 75, 78, 82, 84, 86, 96], "ansitowin32": 33, "answer": 84, "anticip": [35, 82, 86], "anvil": 35, "anvil_correct": 71, "anyon": 0, "anywai": [82, 86, 87], "ap": [73, 74, 77, 78, 79, 82, 85, 86], "apach": 71, "apache_install_di": 48, "apart": [7, 81, 82, 86, 87], "api": [22, 24, 25, 26, 83], "app": 79, "appar": [76, 81, 86, 87], "apparatu": [2, 4], "appear": [2, 29, 36, 45, 71, 73, 74, 76, 79, 82, 84, 86, 87], "append": [4, 11, 14, 24, 44], "appendix": 18, "appl": [2, 11, 40, 64, 79, 84, 95], "appli": [0, 1, 3, 4, 11, 14, 15, 18, 21, 24, 46, 52, 53, 54, 59, 60, 61, 63, 72, 73, 75, 76, 78, 82, 83, 84, 86, 87, 88], "applic": [44, 54, 72, 73, 82, 84, 86, 87, 91], "apply_hkl_offset": 11, "apply_mask": 71, "apply_symmetri": 11, "appreci": 11, "approach": [1, 11, 76, 95], "appropri": [2, 7, 11, 12, 14, 15, 23, 40, 43, 53, 59, 60, 63, 66, 74, 75, 76, 79, 81, 83, 84, 87, 88], "approxim": [14, 35, 37, 43, 63, 72, 74, 77, 81, 84], "apr": [48, 95], "aquila": 74, "ar": [0, 1, 2, 3, 4, 7, 9, 11, 14, 15, 16, 18, 22, 23, 24, 25, 26, 33, 35, 38, 40, 41, 43, 44, 46, 47, 48, 51, 52, 53, 54, 55, 57, 58, 59, 60, 61, 62, 63, 65, 66, 69, 70, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 91, 92, 93, 94, 95, 96, 97], "arb": 95, "arbitrari": 31, "arbitrarili": 2, "arc": [51, 74], "architectur": 95, "archiv": [7, 75, 78], "area": [1, 47, 74, 84, 86, 87, 97], "aren": 40, "arg": [4, 11, 14, 24, 33], "arg1": [10, 12, 14, 22, 23, 24, 25, 26], "arg2": [10, 12, 22, 23, 24, 25, 26], "arg3": [10, 12, 23, 24, 25, 26], "arg4": [10, 12, 25, 26], "arg5": [10, 12, 25], "arg6": [10, 25], "arg7": 25, "argpars": 33, "argu": [2, 84], "argument": [7, 14, 15, 26, 31, 33, 52, 53, 64, 66], "argumenthandlingerrorinfo": [32, 33], "argumentpars": [6, 32, 33], "argumentparserbas": [32, 33], "argv": 83, "aris": 92, "arm": 25, "around": [1, 18, 34, 47, 50, 51, 53, 59, 60, 74, 76, 78, 83, 87, 97], "arrai": [1, 4, 11, 14, 15, 18, 32, 33, 42, 54, 55, 63, 72, 90, 97], "arrang": [2, 81, 84], "array_famili": [3, 4, 11, 83], "arrayscalingmodel": 15, "art": [74, 87], "artefact": 81, "articl": 74, "as_dict": 18, "as_fil": 24, "as_grid_scan": 52, "as_imageset": 26, "as_json": [18, 24], "as_str": 22, "ascii": [3, 74, 87], "ascrib": 11, "ashton": [0, 95, 97], "asid": 78, "ask": [48, 76, 83, 84], "asmit": 0, "aspect": [2, 75], "assembli": 74, "assert": [6, 52], "assert_is_compatible_unit_cel": 22, "assess": [11, 48, 73, 74, 76, 82, 83, 84, 86, 87, 96], "assign": [11, 22, 53, 72, 77, 82, 83, 84, 86, 87, 88], "assign_indic": 11, "assignindicesglob": 11, "assignindicesloc": 11, "assignindicesstrategi": 11, "assmann": 84, "associ": [4, 11, 14, 15, 53, 59, 60, 68, 83, 93, 95], "assum": [1, 2, 7, 14, 21, 22, 23, 25, 29, 35, 37, 46, 48, 74, 75, 79, 81, 83, 84, 88], "assumpt": [1, 23, 35, 76, 78, 83], "assur": 53, "asu": [37, 73], "asymmetr": [44, 56, 77, 94], "asymptot": [82, 84, 86], "atom": [2, 63, 76, 84], "attach": 25, "attempt": [4, 24, 34, 35, 53, 63, 76, 83, 88, 96], "attende": 99, "attent": [74, 76, 87], "attenu": 35, "attribut": [14, 15, 33], "attributes_level": 7, "aug": 95, "augment": 36, "author": 73, "auto": [1, 11, 18, 40, 44, 45, 47, 49, 51, 52, 53, 54, 59, 60, 62, 63, 64, 69, 72, 82, 83, 86, 87], "auto_reduct": [53, 59, 60], "autoindex": [53, 79, 82, 86, 87], "autom": [84, 97], "automat": [1, 9, 11, 18, 33, 40, 48, 53, 59, 60, 66, 72, 74, 75, 79, 82, 83, 84, 85, 86, 87, 88, 95], "automatic_default_fre": 79, "automatic_default_scaled_unmerg": 79, "autotyp": 18, "auxiliari": 14, "avail": [0, 1, 4, 9, 14, 21, 26, 35, 47, 54, 63, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 91, 94, 96], "averag": [1, 38, 42, 55, 63, 82, 86, 87], "average_detector": 38, "average_hierarchy_level": 38, "avoid": [0, 14, 33, 53, 59, 60, 72, 74, 81, 82, 83, 86], "aw": 95, "awai": [75, 81], "awkward": 74, "ax": [2, 14, 25, 34, 35, 52, 57, 62, 74, 75, 76, 78, 84], "axford": [11, 83, 95], "axi": [2, 4, 6, 21, 22, 23, 25, 33, 34, 38, 52, 53, 59, 60, 72, 73, 75, 76, 77, 78, 82, 84, 85, 86, 87], "axial": [69, 88], "axis_and_angle_as_r3_rotation_matrix": 6, "a\u00b2": [82, 84, 86], "b": [1, 2, 14, 15, 18, 21, 22, 40, 53, 59, 60, 61, 63, 72, 73, 74, 76, 77, 78, 79, 81, 82, 84, 85, 86, 87, 88, 95], "b_cart": [82, 84, 86], "b_factor": 11, "b_iso": [11, 53], "ba": 95, "bacaj": 95, "back": [1, 54, 63, 73, 74, 76, 81, 83, 87], "background": [3, 19, 31, 32, 41, 47, 51, 54, 74, 78, 82, 85, 86, 87, 95], "background_gradi": 47, "background_s": [16, 47], "backgroundgradientfilt": [16, 19], "backstop": 81, "bacteri": 95, "bad": [14, 54, 74, 78, 79, 81, 82, 83, 84, 86, 87, 93], "bad_refer": 54, "badli": [78, 87], "bag": 84, "bagtrain": 84, "balanc": 48, "band": [53, 74], "bandwidth": 53, "bank": 74, "bar": 33, "barn": 95, "base": [0, 1, 4, 9, 10, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 30, 31, 33, 38, 43, 46, 53, 59, 60, 63, 64, 70, 79, 82, 83, 84, 86, 87, 88, 95, 97], "base_package_opt": 33, "bash": [7, 74, 75, 76, 83], "basi": [2, 11, 18, 24, 39, 53, 60, 61, 73, 74, 76, 77, 82, 83, 84, 85, 86, 88], "basic": [1, 2, 7, 14, 76, 82, 84, 86, 87], "basic_imageset_from_dict": [27, 30], "basic_imageset_to_dict": [27, 30], "basic_str": [22, 23, 24, 25, 26], "basis_vector": 11, "basis_vector_combin": 53, "basis_vector_search": [4, 19], "basis_vector_search_strategi": 4, "basisvectorminimis": 11, "basisvectorsearch": 11, "basisvectortarget": 11, "batch": [1, 33, 44, 52, 63, 72, 73, 76, 79, 84, 88, 96], "batch_offset": [29, 33, 52], "batch_rang": 43, "batch_siz": 96, "batenburg": 97, "baxter": 95, "bbox": [3, 12], "bc": 2, "beal": 95, "beam": [1, 2, 3, 4, 6, 11, 22, 23, 24, 26, 27, 32, 33, 34, 35, 37, 38, 41, 47, 51, 52, 53, 54, 57, 58, 59, 60, 64, 68, 74, 75, 76, 77, 81, 82, 83, 84, 86, 87, 93, 94, 95, 97], "beam_centr": 23, "beam_prob": 52, "beam_restraint": 53, "beam_typ": 52, "beambas": [10, 24, 26], "beamcomparison": [24, 27], "beamfactori": [21, 27], "beamlin": [2, 4, 35, 44, 48, 78, 81, 82, 84, 85, 86, 87, 90, 95, 97], "beamstop": 73, "beaten": 97, "becaus": [2, 11, 42, 73, 74, 78, 81, 82, 83, 86, 87], "becker": 95, "becom": [1, 2, 14, 63, 76, 78, 83], "been": [1, 15, 23, 25, 29, 40, 47, 52, 53, 59, 60, 73, 74, 75, 76, 77, 81, 82, 83, 84, 85, 86, 87, 88, 96], "befor": [2, 7, 23, 35, 37, 38, 41, 53, 54, 59, 60, 63, 68, 73, 74, 75, 76, 77, 81, 82, 83, 84, 85, 86, 87, 88, 91], "beforehand": 74, "begin": [1, 2, 53, 73, 82, 86, 87], "behav": [42, 82, 86], "behavior": 84, "behaviour": [53, 59, 60, 74], "behen": 51, "bei": 83, "beilsten": [0, 84, 95], "being": [3, 6, 12, 14, 18, 25, 42, 53, 55, 59, 60, 63, 73, 74, 76, 78, 81, 82, 83, 84, 86, 87, 88, 93, 94], "belong": [37, 52, 77, 83], "below": [1, 3, 11, 35, 38, 40, 44, 47, 52, 53, 54, 59, 60, 63, 72, 73, 78, 82, 83, 84, 86, 87, 88], "benefici": [73, 87], "benefit": [0, 90, 97], "benjamin": 0, "benschoten": 95, "bergmann": 95, "berkelei": [0, 90, 92, 99], "bernoulli": 84, "bernstein": [2, 40, 84, 95], "best": [1, 2, 4, 11, 18, 40, 44, 45, 53, 59, 60, 63, 70, 72, 73, 74, 76, 81, 82, 83, 84, 85, 86, 87, 95], "best_model": 11, "best_monoclinic_beta": [11, 18, 40, 60, 69, 72, 74, 82], "best_subgroup": 18, "best_unit_cel": [33, 44, 63], "beta": [2, 18, 40, 60, 69, 72, 82, 84, 86, 87, 88], "betalactamase_sum": 86, "better": [48, 64, 73, 74, 76, 82, 83, 84, 86, 87, 93], "between": [0, 1, 2, 3, 11, 14, 15, 18, 21, 35, 37, 39, 40, 41, 44, 45, 47, 51, 52, 53, 54, 58, 59, 60, 61, 63, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 93], "bewar": 81, "beyond": [73, 82, 86, 87, 94], "bfg": [14, 18], "bh": 95, "bhowmick": 0, "bi": [82, 84, 86], "bia": [53, 59, 60], "bias": 72, "bib": [79, 84], "bibliograph": 2, "bibtex": [79, 84], "big": [74, 82, 86, 87], "billi": 0, "bin": [1, 15, 37, 38, 43, 45, 47, 48, 51, 53, 54, 60, 63, 72, 73, 74, 79, 81, 82, 83, 84, 85, 86, 87], "bin_size_fract": [53, 59, 60, 81], "binari": 92, "binning_method": [43, 72], "biol": [75, 95], "biolog": 95, "biologi": [90, 97, 98], "biomed": 90, "biosci": 73, "biostruct": [95, 97], "biotin": 80, "biotin16": 73, "biotin_p212121": 73, "biotin_p222": 73, "bit": [3, 24, 74, 76], "bitmap": 45, "bk": 95, "bl": 95, "bl32xu_group2_data": 76, "blah_": 93, "blame": 76, "blank": 75, "blend": 80, "blind": 76, "block": [14, 24, 53, 54, 59, 60, 63, 66, 76, 81, 82, 83, 86, 87, 93], "block_centr": 14, "block_siz": [12, 66, 82, 86], "block_size_unit": 12, "block_width": [53, 59, 60, 73, 75], "blockcalcul": [14, 19], "blockwis": 1, "blue": [45, 74, 82, 86, 87], "blur": [47, 51], "bn": 73, "bodi": [53, 59, 60], "bogan": 95, "bold": 72, "bolotovski": [0, 11], "bool": [4, 10, 11, 12, 14, 15, 16, 18, 21, 22, 23, 24, 25, 26, 37, 38, 40, 41, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 62, 63, 64, 65, 67, 68, 69, 70, 72], "boolean": [15, 31, 46], "boost": [0, 22, 23, 24, 25, 26, 35, 73], "boost_python": 12, "bootstrap": [9, 83], "bootstrap_cryst": 53, "border": [47, 50, 51, 53], "boston": 99, "both": [0, 2, 18, 35, 52, 53, 59, 60, 63, 70, 72, 73, 74, 78, 82, 84, 85, 86, 87], "botha": 95, "bother": 83, "bottom": [73, 74, 78, 87], "bound": [3, 11, 12, 18, 47, 50, 51, 53, 54, 66], "boundari": [82, 86], "bourenkov": 0, "bourn": 7, "boutet": 95, "box": [3, 12, 47, 53, 73, 74, 87], "bq": 73, "bracket": [40, 84], "bragg": 78, "branch": 87, "bravai": [40, 60, 74, 78, 84, 85], "bravais_setting_": 60, "bravais_setting_1": [60, 82, 86], "bravais_setting_2": [74, 82, 86], "bravais_setting_3": 86, "bravais_setting_4": 86, "bravais_setting_5": [75, 77, 85, 86], "bravais_setting_n": [82, 86], "bravais_summari": [82, 86], "bravais_t": 11, "breadth": 23, "break": [74, 93], "brehmer": 95, "brewster": [0, 95], "bricogn": [0, 11, 97], "bright": [45, 51, 73, 82, 86], "brilliant": 97, "bring": [73, 76, 83], "brookhaven": 2, "brotat": 72, "brought": 97, "browser": [71, 73, 76, 82, 84, 86], "bruhn": 73, "brunger": 95, "bst": 84, "buffer": [58, 72], "buffer_s": 58, "bug": 90, "build": [0, 9, 14, 79], "build_dial": 33, "build_up": 14, "built": 4, "bullet": 97, "buse": 2, "busi": 92, "button": [78, 82, 86, 87], "bypass": 55, "bz2": [44, 78, 85], "c": [0, 1, 2, 7, 10, 12, 14, 22, 23, 24, 25, 26, 35, 40, 53, 60, 61, 64, 66, 73, 74, 76, 77, 78, 81, 82, 84, 85, 86, 87, 88, 92, 95], "c2": [18, 40, 60, 69, 72, 74, 82, 86], "c222": 86, "c2221": 86, "c2sum_1": [86, 87], "c2sum_1_": 86, "c3h7no2": 44, "c_grid": 10, "ca": [95, 99], "calc_2d_rmsd_and_displac": 11, "calc_acentric_subgroup": 11, "calc_exp_rmsd_t": 14, "calc_n_param_from_bin": 15, "calcul": [0, 1, 2, 6, 11, 12, 14, 15, 18, 34, 35, 37, 39, 40, 41, 43, 47, 51, 53, 54, 58, 59, 60, 61, 63, 68, 72, 74, 76, 78, 82, 84, 85, 86, 87, 88, 95], "calculate_esd": 14, "calculate_gradi": 14, "calculate_new_offset": 15, "calculate_weight": 14, "calculate_weighted_mean": 33, "calero": 95, "calibr": [51, 66, 73, 74, 75, 81], "calibrate_pdb": 51, "calibrate_silv": 51, "calibrate_unit_cel": 51, "call": [2, 14, 16, 35, 40, 47, 48, 53, 54, 72, 74, 76, 82, 83, 86, 87, 96], "callback": 14, "callback_after_step": [14, 18, 82, 84, 86], "cambridg": [33, 99], "came": 74, "camera": 73, "camp": 0, "campaign": 82, "campbel": 11, "can": [1, 2, 3, 4, 7, 9, 11, 14, 16, 21, 23, 24, 33, 35, 37, 38, 40, 42, 44, 45, 47, 48, 51, 52, 53, 54, 55, 59, 60, 61, 63, 68, 69, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 91, 93, 95, 96, 97], "candid": [4, 11, 53, 82, 83, 86, 87], "candidate_basis_vector": 4, "candidate_crystal_model": 4, "candidate_orientation_matric": 11, "candidate_outlier_reject": 53, "candidate_spot": 53, "cannot": [47, 73, 74, 78, 81, 93], "canon": 25, "capabl": [48, 74, 90], "caption": 35, "captur": [82, 83, 86, 87], "carbon": 35, "care": [76, 81, 82, 83, 86, 87], "carefulli": [73, 74, 76], "careless": 78, "carragh": 73, "carri": [40, 82, 83, 86, 87], "carrier": 83, "cart": 84, "cartesian": [2, 11], "cascio": 95, "case": [1, 2, 4, 7, 11, 14, 15, 21, 23, 25, 35, 40, 47, 52, 53, 54, 59, 60, 61, 63, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96, 97], "cat": 75, "catalyst": 95, "cauchi": 18, "caus": [14, 15, 74, 77, 78, 82, 86, 87, 92, 93], "caution": 14, "cautionari": 78, "cb_op": [11, 18, 60, 73, 74, 77, 78, 82, 85, 86], "cb_op_inp_min": 18, "cbf": [3, 4, 21, 23, 25, 33, 45, 47, 48, 49, 51, 52, 55, 65, 75, 79, 81, 82, 83, 85, 86, 88, 93, 96], "cbf_handl": [21, 23, 25, 29], "cbf_handle_struct": 21, "cbflib": 33, "cc": [18, 40, 43, 72, 73, 74, 77, 78, 79, 81, 82, 84, 85, 86, 87, 88], "cc1": [1, 18, 73, 82, 84, 85, 86], "cc_": 84, "cc_against": 18, "cc_ano": [73, 82, 84, 85, 86], "cc_for": 18, "cc_half": [43, 72, 79, 84], "cc_half_fit": [43, 72], "cc_half_method": [43, 72], "cc_half_significance_level": [43, 72], "cc_n_bin": 60, "cc_pearson": [74, 82, 85, 86], "cc_ref": [43, 72], "cc_sig_fac": 18, "cc_spearman": [74, 82, 85, 86], "cc_true": 18, "cc_weight": [18, 40, 72], "ccano": 84, "ccd": [23, 42, 78, 82, 86, 87], "ccdc": 73, "cchalf": [63, 72], "cci": [9, 48], "ccp4": [0, 72, 73, 75, 76, 77, 79, 83, 84, 86, 87, 90, 95, 97, 98], "ccp4_scr": 79, "ccp4i2": 87, "ccref": [43, 72], "cctbx": [0, 1, 2, 4, 9, 11, 14, 18, 22, 24, 48, 79, 83, 95], "cctbx_bundl": 33, "cctbx_project": 48, "cc\u00bd": [18, 40, 43, 72, 73, 76, 82, 84, 86], "cd": [7, 9, 33, 48, 73, 74, 76, 79, 81, 83, 84, 91, 95], "cdot": [2, 35], "ce2": [1, 96], "ceas": 76, "cell": [2, 11, 14, 18, 22, 33, 35, 40, 41, 44, 45, 46, 47, 50, 51, 53, 54, 57, 58, 59, 60, 63, 64, 69, 70, 72, 73, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 95, 96], "center": [18, 40, 60, 69, 72, 77, 82, 86], "cento": 48, "centr": [14, 18, 23, 37, 41, 47, 51, 52, 53, 54, 57, 58, 59, 60, 64, 74, 75, 76, 80, 82, 86, 87, 94, 97], "central": [77, 79, 81], "centre_xi": 75, "centric": 84, "centroid": [3, 4, 11, 31, 41, 44, 47, 50, 51, 53, 54, 58, 59, 60, 66, 70, 78, 81, 82, 83, 85, 86, 87], "centroid_": 3, "centroid_definit": [41, 51, 54, 58], "centroid_diff_i": [62, 81], "centroid_diff_max": 62, "centroid_diff_x": [62, 81], "centroidanalysi": 14, "certain": [11, 35, 38, 53, 54, 59, 60, 63, 72, 73, 84, 88], "certainli": 53, "ceta": 73, "cgi": 48, "ch": [44, 74], "chain": [4, 77], "challeng": [0, 73, 74, 77, 78, 87, 95, 97], "chanc": [76, 82, 86, 87, 96], "chang": [1, 2, 9, 18, 24, 33, 39, 41, 51, 53, 54, 58, 60, 61, 63, 66, 72, 73, 74, 75, 76, 77, 81, 82, 85, 86, 87, 95, 96, 97], "change_basi": 24, "change_of_basis_op": [11, 18, 24, 61, 69, 74, 77, 82, 86], "change_of_basis_op_to_best_cel": [18, 19], "chapui": 2, "char": [22, 23, 24, 25, 26], "char_trait": [22, 23, 24, 25, 26], "charact": [12, 51, 52], "characteris": 81, "characteristic_grid": [11, 53], "chatterje": 95, "chdir": 83, "cheat": 74, "check": [1, 4, 7, 9, 16, 18, 24, 26, 33, 37, 38, 53, 63, 69, 74, 76, 79, 81, 82, 83, 84, 86, 93], "check_consistent_index": 63, "check_doubled_cel": [11, 53], "check_flag": 16, "check_format": [6, 24, 26, 30, 33, 83], "check_head": 26, "check_indexing_symmetri": [71, 78], "check_misindex": 53, "check_reference_geometri": 52, "checkbox": [74, 87], "checkout": 9, "checkpoint": [53, 59, 60], "chemic": 44, "cheng": 73, "chi": [53, 59, 60], "chiang": 73, "chiral": [73, 74, 82, 84, 86], "chmod": 74, "chno": [73, 88], "choi": 95, "choic": [1, 2, 15, 18, 34, 38, 39, 40, 41, 43, 44, 45, 47, 51, 52, 53, 54, 57, 58, 59, 60, 62, 63, 68, 69, 72, 73, 76, 77, 82, 84, 86, 87, 88], "choleski": 14, "chollet": 95, "choos": [2, 18, 38, 44, 53, 59, 60, 63, 72, 73, 74, 77, 81, 82, 86, 87, 89], "choose_best_orientation_matrix": 11, "chose": [75, 81, 87], "chosen": [1, 2, 4, 11, 14, 15, 18, 35, 38, 43, 53, 57, 59, 60, 62, 63, 74, 76, 77, 82, 84, 85, 86, 87], "choudhuri": 83, "chunksiz": [47, 82, 86], "cif": [2, 40, 44, 61, 63, 70, 72, 76], "cif_fil": [21, 23, 25, 29], "cif_pet": 44, "circ": 2, "circl": [2, 47, 50, 51, 73, 76, 82, 86], "circular_grid": [41, 51, 54, 58], "circumst": [29, 53, 59, 60, 93], "circumv": 78, "citat": [79, 84], "cite": 72, "cl": 4, "clabber": [74, 75, 95], "claim": [4, 74], "clarif": 7, "clark": [0, 95], "clash": 33, "class": [2, 6, 10, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 30, 31, 33, 41, 45, 47, 51, 52, 54, 55, 58, 73, 74, 75, 82, 83, 85, 86], "classifi": [15, 47], "classmethod": [4, 14, 15, 22, 31, 33], "clean": [53, 74, 81], "cleanup": 33, "clear": [2, 24, 40, 77, 78, 81, 83, 84, 87, 88, 93, 97], "clear_cach": 26, "clearli": [2, 74, 78, 81, 82, 83, 86, 87], "clibd": 79, "click": [71, 73, 74, 77, 78, 79, 80, 81, 83, 84, 85, 86, 87, 88, 91], "client": 71, "client_serv": 48, "close": [1, 14, 24, 53, 59, 60, 66, 73, 74, 75, 77, 81, 82, 83, 86, 87], "close_to_spindle_cutoff": [14, 53, 59, 60, 81], "closer": [48, 74, 81, 83], "closest": [48, 82], "cloud": 87, "clumsi": 29, "cluster": [16, 18, 38, 40, 47, 48, 54, 72, 82, 83, 84, 86, 96], "cluster_1": [40, 84, 96], "cluster_2": 96, "cluster_20": 76, "cluster_analysi": 53, "cluster_id": [40, 84, 96], "cluster_method": 72, "cm": 95, "cmd": 83, "co": [2, 35, 76, 84, 95], "coars": [53, 64], "code": [0, 2, 4, 6, 9, 51, 74, 83, 92, 95, 96], "coeffici": [18, 35, 37, 40, 60, 72, 78, 81, 82, 86, 87], "cohen": 95, "coincid": [2, 25], "col": 6, "col_select": [14, 59, 70], "colin": 86, "collabor": [0, 90, 97, 98], "collat": 35, "collect": [11, 15, 49, 66, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96, 97], "colleti": 95, "collinear": 11, "color_schem": 51, "colorama": 33, "colour": [32, 33, 45, 62, 68, 82, 86, 87], "colour_map": 68, "colour_schem": 45, "colspot": 30, "column": [1, 3, 6, 14, 33, 53, 54, 59, 60, 63, 70, 77, 78, 84, 85], "com": [9, 41, 48, 51, 54, 58, 73, 75, 79], "comb": 38, "combin": [1, 2, 11, 15, 18, 38, 40, 44, 46, 47, 51, 53, 54, 59, 60, 63, 70, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 88, 93], "combine0": 76, "combine_crystal_model": [70, 72], "combine_experi": [71, 81, 83, 93], "combine_parti": [33, 44], "combine_scan": 53, "combined_scor": 11, "come": [76, 83], "comfort": [83, 87], "command": [1, 4, 7, 9, 32, 33, 48, 52, 63, 71, 73, 74, 75, 76, 79, 80, 81, 82, 83, 85, 86, 87, 88, 91, 96], "command_lin": [33, 83], "committe": 99, "common": [2, 18, 29, 40, 63, 73, 78, 82, 84, 86, 89], "commonli": [1, 14, 74, 76, 77, 87], "commun": [2, 74, 95], "comp": [73, 82, 84, 85, 86], "compact": [2, 11, 18, 24, 44, 52, 81], "companion": [82, 86, 87], "compar": [15, 37, 38, 44, 63, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 96], "compare_beam": [24, 33], "compare_detector": [24, 33], "compare_goniomet": [24, 33], "compare_model": [38, 83], "compare_orientation_matric": [11, 71], "comparison": [2, 11, 24, 37, 38, 39, 53, 63, 81, 83], "compat": [38, 74, 78], "compens": [75, 86], "compil": [9, 48, 91], "complet": [0, 7, 14, 21, 43, 48, 53, 56, 59, 60, 63, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 93, 97], "complete_set": 26, "complex": [4, 7, 21, 23, 38, 82, 87], "compli": 44, "compliant": 75, "complic": 83, "compon": [0, 1, 2, 4, 15, 25, 40, 47, 56, 63, 76, 82, 83, 84, 86, 87], "compos": [4, 14, 15, 25, 53, 59, 60, 88], "compose_model_p": [53, 59, 60], "composit": [2, 44], "comprehens": 97, "compress": [7, 44, 45, 78], "compress_level": 45, "compris": 83, "compromis": 1, "comput": [0, 1, 2, 11, 18, 31, 39, 41, 44, 47, 51, 54, 58, 64, 67, 76, 79, 82, 84, 94, 95, 96], "computation": [1, 87, 97], "compute_background": 31, "compute_centroid": 31, "compute_delta_cchalf": [76, 84], "compute_funct": [11, 18], "compute_functional_and_gradi": [11, 14, 18], "compute_functional_gradients_and_curvatur": [14, 18], "compute_functional_gradients_diag": [14, 18], "compute_gradi": 18, "compute_gradients_fd": 18, "compute_mean_background": [16, 47], "compute_residu": 14, "compute_residuals_and_gradi": 14, "compute_restraints_functional_gradients_and_curvatur": 14, "compute_restraints_residuals_and_gradi": 14, "compute_threshold": 31, "concaten": 14, "concentr": [53, 59, 60], "concern": [2, 78], "conclud": [40, 77, 81, 82, 85, 86, 87], "concomit": 97, "concret": 14, "concurr": [14, 63], "cond": 14, "conda3": 91, "conda_bas": 9, "condit": [14, 53, 59, 60, 69, 74, 92], "conf": 48, "confid": [18, 37, 40, 73, 74, 76, 82, 84, 85, 86, 87], "config": [47, 83], "config_opt": 33, "config_refineri": 14, "config_restraint": 14, "config_spars": 14, "config_target": 14, "configdict": [4, 15], "configur": [4, 9, 14, 15, 21, 23, 33, 48, 53, 59, 60, 63, 70, 79, 81, 82, 83, 84, 86, 88], "configuration_paramet": 4, "configure_compon": [4, 15], "configure_filt": 16, "configure_modul": 33, "configure_threshold": 16, "confirm": 84, "conform": 95, "confus": [2, 84], "conjunct": [47, 54], "connect": [47, 56, 62, 84], "connected": [1, 63, 72], "consecut": [4, 15, 52, 55, 63], "consecutive_refinement_ord": [4, 15], "consequenti": 92, "conserv": 11, "consid": [37, 41, 47, 50, 51, 53, 54, 58, 74, 76, 77, 82, 84, 86, 88], "consider": [47, 77, 82, 86, 87], "consist": [1, 2, 11, 14, 18, 40, 53, 60, 61, 63, 72, 74, 76, 77, 78, 82, 83, 84, 85, 86, 87, 88, 97], "const_ref": [10, 12, 25, 26], "constant": [2, 14, 53, 54, 59, 60, 75, 88], "constant2d": 54, "constant3d": 54, "constantweightingstrategi": [14, 19], "constrain": [1, 11, 53, 59, 60, 63, 82, 86, 87], "constraint": [1, 11, 14, 53, 59, 60, 70, 74, 82, 83, 85, 86, 87, 88], "constraints_manag": 14, "construct": [4, 11, 14, 16, 21, 23, 25, 29, 30, 74, 75], "constructor": [21, 33], "consum": [73, 83], "contact": 79, "contain": [1, 3, 4, 9, 11, 14, 15, 16, 18, 24, 34, 38, 40, 44, 46, 47, 52, 53, 54, 59, 60, 61, 62, 63, 70, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 87, 96, 98], "content": [30, 33, 44, 73, 74, 82, 83, 85, 86, 87], "context": [2, 94], "contigu": [47, 93], "continu": [0, 53, 59, 60, 73, 74, 77, 78, 82, 83, 85, 86, 87, 93], "contract": [0, 90, 92], "contradict": 35, "contrari": 77, "contrast": [74, 87], "contribut": [0, 18, 53, 59, 60, 76, 83], "contributor": [0, 92], "control": [14, 38, 43, 44, 53, 54, 59, 60, 70, 74, 87, 89, 95, 97], "conveni": [1, 2, 47, 54, 63, 69, 72], "convent": [8, 22, 52, 53, 61, 64, 66, 77, 82, 88], "convention": 2, "converg": [14, 41, 51, 54, 58, 63, 81], "convergence_as_shift_over_esd": 14, "convers": 95, "convert": [2, 12, 14, 16, 21, 22, 23, 24, 25, 26, 28, 29, 30, 52, 53, 70, 73, 88], "convert_reflections_z_to_deg": 11, "convert_sequences_to_stil": 52, "convert_stills_to_sequ": 52, "convert_to_cambridg": [32, 33], "convinc": 78, "convolut": [47, 51], "cooper": 11, "coord": 18, "coordin": [18, 22, 23, 25, 47, 50, 51, 52], "cope": [6, 97], "copi": [0, 14, 24, 26, 50, 74, 75, 77, 81, 83, 93], "copyright": 92, "core": [0, 81, 83, 88, 95, 96], "core_paramet": 11, "corner": [47, 50, 51, 81, 82, 86, 87], "correct": [1, 2, 3, 4, 15, 18, 23, 30, 35, 44, 47, 50, 51, 52, 54, 63, 65, 72, 74, 75, 76, 77, 80, 82, 83, 84, 86, 87, 88], "corrected_integr": 81, "corrected_refin": 81, "corrected_sv_refin": 81, "correctli": [4, 7, 37, 40, 74, 88], "correl": [3, 14, 18, 37, 40, 53, 59, 60, 61, 70, 72, 74, 76, 78, 79, 81, 82, 83, 84, 86, 87, 88], "correlation_plot": [59, 70, 83], "correlationcoefficientaccumul": [18, 19], "correspond": [4, 6, 11, 14, 33, 36, 53, 54, 73, 74, 77, 78, 82, 83, 84, 86, 87], "corrplot": [70, 83], "corrplot_x": 83, "cos_angl": 72, "cosin": 44, "cost": 86, "cosym": [19, 32, 63, 71, 72, 73, 76, 84], "cosymanalysi": [18, 19], "could": [14, 29, 53, 59, 60, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93], "count": [18, 40, 66, 72, 74, 76, 78, 82, 84, 85, 86, 87, 97], "counting_sort": [43, 72], "coupl": [1, 83], "cours": [2, 82, 87, 88], "cov": 80, "covari": [53, 59, 60, 87], "cover": [1, 47, 54, 76, 82, 86, 87], "coverag": [1, 81], "cpu": [81, 83, 97], "cpv17": 95, "creat": [1, 4, 7, 9, 14, 15, 16, 22, 23, 24, 26, 28, 38, 48, 50, 53, 54, 59, 60, 63, 70, 74, 75, 76, 82, 83, 86, 87, 88, 96], "create_profile_model": [54, 71], "cred": [47, 54, 63, 66, 69, 72], "criteria": [14, 43, 46, 76, 82, 84, 86], "criterion": [14, 53, 59, 60, 63, 82, 84, 86, 87], "critic": [76, 81, 97], "croll": 74, "cross": [63, 74, 75, 82, 84, 86], "cross_valid": 63, "cross_validation_mod": 63, "crossov": [1, 81], "crucial": 36, "cryst": [0, 11, 18, 40, 64, 69, 72, 77, 79, 84], "crystal": [1, 2, 3, 4, 6, 11, 15, 18, 24, 27, 30, 32, 33, 34, 38, 40, 44, 47, 48, 52, 53, 54, 57, 59, 60, 62, 63, 65, 66, 68, 69, 70, 72, 73, 74, 75, 77, 78, 79, 80, 81, 82, 85, 86, 87, 88, 93, 95, 96], "crystal_a": 11, "crystal_b": 11, "crystal_id": [60, 85], "crystal_model": [11, 22], "crystal_nam": [33, 44, 63], "crystalbas": [22, 24], "crystalfactori": [22, 27], "crystallin": [84, 95], "crystallis": [83, 84], "crystallogr": [2, 75, 95], "crystallograph": [0, 1, 2, 70, 72, 76, 77, 82, 95], "crystallographi": [0, 1, 2, 73, 74, 90, 94, 96, 97], "crystfel": 97, "cs03r": 79, "csh": [7, 48], "ctruncat": [77, 86], "cubic": 35, "culprit": 78, "cumbersom": 76, "curl": [9, 48, 75, 91], "current": [2, 4, 7, 14, 18, 24, 33, 44, 53, 55, 59, 60, 63, 69, 75, 77, 78, 81, 83, 87, 91, 93, 94, 96, 97], "current_image_0": 15, "cursor": 87, "curtail": 11, "curv": [18, 43, 74, 78, 81], "curvatur": [14, 18, 40, 72], "curvatures_fd": 18, "cusp": 34, "custom": [4, 63], "cut": [1, 44, 53, 59, 60, 63, 74, 97], "cut_data": [63, 84], "cutoff": [1, 11, 18, 38, 40, 43, 44, 53, 54, 59, 60, 63, 72, 73, 76, 82, 84, 86, 87], "cutoff_criterion": 53, "cyan": 87, "cycl": [15, 41, 51, 53, 54, 58, 59, 63, 64, 72, 78, 81, 82, 84, 86, 87], "cyst_0": 88, "d": [0, 1, 2, 4, 11, 18, 22, 23, 25, 29, 30, 31, 40, 44, 46, 47, 50, 51, 53, 58, 63, 73, 74, 75, 78, 79, 81, 82, 83, 84, 86, 95, 97], "d55": 84, "d62": [18, 69], "d66": 0, "d67": [18, 69, 79], "d70": 11, "d74": [18, 40, 79, 84], "d76": 84, "d78": [72, 84], "d_": 81, "d_ep": 72, "d_max": [37, 41, 46, 47, 50, 51, 54, 56, 63, 72, 73, 74, 75, 82, 83, 84, 85, 86, 87], "d_min": [1, 11, 18, 33, 37, 38, 40, 41, 44, 46, 47, 48, 49, 50, 51, 53, 54, 56, 58, 63, 64, 69, 72, 73, 74, 75, 76, 82, 83, 84, 85, 86, 87, 88], "d_min_fin": 53, "d_min_method_1": 49, "d_min_method_2": 49, "d_min_start": 53, "d_min_step": [53, 82, 86], "d_rang": [1, 63, 72], "d_space": [45, 46, 47, 50, 51, 84], "d_star_toler": 53, "dai": 98, "dallakyan": 73, "dalton": 0, "damag": [1, 72, 73, 74, 78, 81, 82, 84, 86, 87, 92], "damerel": 95, "damping_valu": 14, "daniel": 0, "danni": 83, "dano": [33, 84], "daresburi": 0, "darmanin": 74, "dat": [83, 84], "data": [0, 4, 5, 7, 8, 11, 12, 14, 15, 16, 18, 24, 26, 33, 35, 40, 41, 43, 44, 47, 48, 49, 52, 53, 54, 55, 59, 60, 61, 62, 63, 66, 69, 70, 72, 77, 78, 79, 80, 81, 83, 84, 85, 89, 90, 92, 93, 94, 95, 97, 98], "data_par": 75, "datablock": [24, 75], "datafil": [1, 79, 82, 83, 85, 86], "dataset": [15, 18, 33, 40, 44, 47, 53, 54, 59, 60, 61, 63, 69, 72, 74, 76, 77, 78, 81, 82, 84, 85, 86, 87, 89, 97], "dataset_id": 33, "dataset_select": 63, "datastructur": 15, "datatyp": 14, "date": [14, 81], "datum": [2, 35], "dave": [81, 97], "david": [0, 97, 98], "dbscan": 53, "de": [0, 90, 95], "dead": [46, 81], "dead_tim": 46, "deal": [2, 75, 81, 87], "dealt": 78, "debug": [14, 44, 53, 54, 57, 59, 81, 82, 86, 87], "debug_centroid_analysi": [53, 59, 60], "dec": 95, "decad": 0, "decai": [1, 15, 63, 73, 82, 84, 86, 88], "decay_correct": [1, 63, 87], "decay_interv": [1, 63], "decay_restraint": [1, 63], "decay_term": 1, "decid": [4, 76], "decim": [44, 53, 59, 60], "decis": 2, "declar": 75, "decod": 24, "decompos": [2, 57, 62], "decomposit": [57, 62], "decompress": 14, "deconvolut": [41, 51, 54, 58], "decreas": [73, 74, 81, 82, 83, 84, 85, 86, 87], "dectri": [48, 81], "deem": 44, "deep": 81, "def": [4, 6, 83], "default": [1, 7, 11, 14, 15, 18, 24, 31, 33, 34, 35, 43, 44, 45, 48, 52, 53, 55, 59, 60, 61, 63, 64, 66, 68, 70, 72, 74, 75, 78, 79, 81, 82, 85, 86, 87, 88, 96], "defin": [2, 14, 15, 18, 43, 46, 47, 50, 51, 53, 54, 63, 73, 74, 75, 88], "define_entry_point": 4, "definit": [2, 14, 15, 21, 33, 74, 75, 78, 83], "defpix": 30, "deg": [6, 14, 21, 22, 23, 25, 29, 40, 81, 82, 83, 84, 85, 86, 87, 96], "degeneraci": 74, "degre": [1, 2, 11, 15, 23, 25, 35, 40, 41, 51, 53, 54, 58, 59, 60, 63, 66, 68, 72, 74, 77, 81, 82, 83, 84, 85, 86, 87, 88], "del_last_row": 14, "deleg": [4, 14], "delet": [14, 38, 54], "delete_integration_shoebox": 63, "delete_shoebox": [38, 54], "deliv": 90, "deliver": 95, "delpsi": 14, "delpsi_const": [14, 53, 59, 60], "delpsic": 14, "delta": [11, 14, 18, 40, 41, 51, 53, 54, 58, 63, 72, 73, 78, 82, 84, 85, 86, 87, 96], "delta_cc_half": [76, 84], "delta_cchalf": 84, "deltacchalf": [63, 72, 74], "deltapsi": 14, "demand": 87, "demonstr": [6, 76, 77, 87, 97], "dendrogram": [38, 40, 72, 83], "denomin": 18, "dens": 14, "densiti": [11, 18, 35, 53, 77], "depart": [0, 90, 94], "depend": [1, 2, 14, 35, 44, 48, 59, 62, 63, 76, 81, 82, 86, 87, 88], "depict": 83, "depont": 95, "deposit": 73, "deprec": 63, "depth": [1, 4, 23], "derefer": 26, "derek": 0, "deriv": [2, 4, 6, 14, 22, 84, 87, 88, 92], "describ": [2, 3, 7, 18, 48, 53, 59, 60, 74, 75, 77, 82, 83, 84, 85, 86, 87, 88, 95], "descript": [2, 3, 4, 7, 21, 23, 47, 63, 74, 82, 83, 86, 87, 96], "design": [0, 2, 11, 23, 25, 53, 94, 95, 97], "desir": [2, 9, 41, 63, 72, 82, 85, 86, 88], "desktop": [81, 83], "despit": [74, 78, 81, 86, 87], "dest_dir_prefix": 33, "detail": [0, 1, 3, 4, 7, 14, 48, 63, 71, 72, 74, 76, 77, 78, 80, 81, 82, 84, 85, 88], "detect": [14, 53, 59, 60, 73, 78, 82, 83, 84, 86, 97], "detector": [0, 1, 2, 3, 4, 6, 10, 11, 14, 21, 24, 26, 27, 30, 32, 38, 41, 42, 45, 46, 47, 48, 50, 51, 52, 53, 54, 55, 58, 59, 60, 63, 73, 75, 76, 78, 80, 82, 83, 84, 86, 87, 88, 90, 93, 95, 97], "detector1": [53, 59, 60], "detector_gain": 54, "detector_spac": [41, 51, 54, 58], "detectorbas": 26, "detectorcomparison": [24, 27], "detectorfactori": [23, 27], "detectornod": 23, "determin": [1, 2, 3, 4, 11, 14, 15, 18, 22, 38, 40, 44, 47, 51, 52, 53, 54, 57, 59, 60, 61, 62, 63, 69, 72, 75, 76, 78, 82, 83, 84, 86, 87, 95], "determine_auto_absorption_param": 15, "determine_esq_outlier_index_arrai": 15, "determine_outlier_index_arrai": 15, "determine_reindex_operator_against_refer": [18, 19], "detract": 76, "dev": [40, 53, 59, 60, 75, 79, 82, 84, 85, 86, 91], "dev20150903": 91, "dev20191028": 79, "develop": [2, 4, 7, 8, 47, 90, 94, 95, 97, 98], "devenish": [0, 95], "deviat": [15, 35, 40, 47, 53, 54, 60, 63, 70, 72, 74, 77, 79, 81, 82, 84, 85, 86, 93], "df": [74, 76, 82, 84, 86, 87, 88], "dg": [73, 75, 95], "dh": 78, "di": [74, 76, 82, 84, 86, 87, 88, 95], "diagnost": [77, 78], "diagon": [14, 18, 77], "dial": [2, 3, 5, 6, 8, 19, 31, 32, 33, 71, 72, 73, 74, 75, 77, 78, 80, 82, 85, 86, 87, 88, 93, 99], "dials_data": 82, "dials_dyn": 44, "dials_env": [7, 91], "dials_regress": 9, "dials_scale_user_guid": [82, 84, 86], "dials_scratch": [53, 59, 60], "dials_tutori": 79, "dialsindexerror": [11, 19], "dialsindexrefineerror": [11, 19], "diamet": 73, "diamond": [0, 35, 80, 81, 82, 83, 84, 85, 86, 87, 90, 91, 92, 98, 99], "diamond_build": 91, "diao": 95, "dict": [14, 15, 18, 21, 23, 24, 25, 26, 33], "dictat": 14, "dictionari": [4, 15, 18, 21, 22, 23, 24, 25, 28, 29, 30, 44], "did": [75, 77, 81, 83, 97], "didn": [82, 83, 86, 87], "diederich": [40, 97], "diff": 33, "diff_phil": 33, "differ": [1, 2, 4, 6, 14, 18, 33, 38, 39, 40, 42, 50, 53, 54, 63, 69, 72, 74, 75, 76, 77, 81, 82, 83, 84, 86, 87, 88, 97], "difference_rotation_matrix_axis_angl": 11, "differenti": [74, 82, 86, 87], "difficult": [11, 53, 74, 78, 81, 83, 84, 87], "difficulti": [73, 77, 78], "diffract": [2, 3, 11, 21, 35, 37, 42, 44, 45, 47, 51, 53, 54, 59, 63, 66, 69, 72, 73, 74, 75, 77, 78, 81, 82, 83, 84, 86, 87, 95, 96, 97, 98], "diffus": [94, 95], "difior": 95, "digit": 52, "dim": [14, 18], "dimens": [11, 14, 18, 23, 40, 53, 59, 60, 63, 72, 74, 76, 82, 83, 84, 86, 87], "dimension": [18, 53, 82, 86], "dimensionless": 11, "dimer": 77, "direct": [2, 3, 4, 11, 21, 23, 25, 34, 38, 44, 52, 53, 59, 60, 69, 73, 74, 76, 77, 78, 82, 84, 86, 87, 92], "direction_toler": 24, "directli": [0, 3, 48, 73, 78, 79, 81, 82, 83, 86, 87, 96], "directori": [4, 7, 9, 24, 29, 30, 44, 45, 52, 57, 60, 73, 74, 75, 76, 79, 82, 83, 84, 88, 91, 93], "dirti": 83, "disabl": [1, 14, 38, 47, 50, 51, 53, 84], "disable_parallax_correct": [47, 50, 51], "disable_unit_cell_volume_sanity_check": 53, "disablempmixin": [14, 19], "discard": 63, "disclaim": 92, "disconnect": 2, "discov": [4, 81], "discret": [53, 59, 60, 63], "discuss": [0, 76, 82, 85, 86, 87, 97], "disk": 48, "disord": 77, "dispatch": 9, "dispers": [31, 45, 47, 51, 75], "dispersion_extend": 47, "dispersion_spotfinder_threshold_ext": 31, "dispersionspotfinderthresholdext": [31, 32], "displac": [2, 11], "displai": [7, 38, 40, 45, 48, 51, 72, 75, 77, 82, 86, 87], "dispos": [76, 78], "disproportion": [82, 86, 87], "disregard": 1, "dist": [48, 75], "dist_path": 4, "distanc": [2, 11, 16, 23, 40, 51, 52, 53, 54, 59, 60, 73, 75, 81, 82, 83, 84, 85, 86], "distinct": [2, 76, 84], "distl": [49, 71], "distort": [75, 78, 82, 86, 87], "distribut": [4, 18, 53, 59, 60, 65, 75, 76, 82, 86, 87, 92, 96], "dive": 74, "diverg": [3, 21, 41, 51, 52, 54, 58, 74, 82, 85, 86, 87], "divid": [53, 59, 60, 63], "divis": 4, "divisori": 3, "djb": 74, "dk": 78, "dl": [33, 78, 79, 82, 86], "dls_sw": 79, "dmax": [17, 74, 82, 83, 85, 86], "dmin": [17, 74, 82, 83, 85, 86], "do": [1, 6, 7, 9, 11, 12, 14, 16, 21, 31, 33, 38, 41, 47, 51, 53, 54, 58, 59, 60, 63, 72, 73, 74, 75, 76, 77, 79, 82, 84, 86, 87, 88, 93, 97], "do_spars": 14, "do_stil": 14, "doak": 95, "docstr": 63, "document": [1, 54, 63, 79, 92], "doe": [2, 7, 14, 17, 36, 44, 51, 52, 53, 55, 62, 73, 74, 81, 82, 83, 84, 86, 87], "doesn": 26, "doi": [11, 47, 53, 59, 60, 75, 82], "domain": [53, 74], "domain_size_ang": 22, "domain_size_toler": 22, "domin": [82, 86, 87], "don": [1, 33, 35, 38, 71, 81, 83], "done": [3, 14, 15, 44, 46, 47, 53, 54, 57, 59, 60, 62, 68, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 93], "dose": [63, 72, 81], "dose_decai": [15, 63, 72], "dosedecai": 15, "dosedecayscalingmodel": 15, "dot": [76, 82, 86], "doubl": [4, 10, 14, 22, 23, 25, 81, 91], "doubt": 73, "down": [1, 73, 74, 77, 82, 86, 87], "download": [7, 48, 71, 73, 74, 75, 78, 82, 85, 86, 87, 91], "downstream": [44, 63, 72, 74, 75, 76, 82, 84, 85, 86, 87, 88], "dozen": 76, "dp": [78, 87, 95], "dpf3": 80, "dpf3_247398": 78, "dr": [0, 53, 59, 60, 95], "draw": 73, "drawn": 84, "drevon": 0, "driessen": [53, 59, 60], "drift": [74, 75], "driven": 87, "drmaa": [47, 54], "drop": 87, "due": [1, 14, 15, 63, 72, 73, 82, 84, 86, 87, 88], "dui": 80, "dummi": 75, "dump": [24, 32, 33], "dure": [1, 2, 4, 14, 15, 40, 41, 48, 49, 50, 51, 53, 54, 58, 59, 60, 63, 72, 73, 74, 75, 76, 77, 82, 83, 84, 85, 86, 87, 96], "dw": 95, "dx": [26, 52, 53, 59, 60, 75], "dxtbx": [3, 4, 9, 10, 11, 14, 32, 73, 75, 81, 82, 83, 85, 86, 95], "dxtbx_ed_format": [73, 75], "dxtbx_model_ext": 21, "dxtbx_name": 30, "dy": [26, 52, 53, 59, 60, 75], "dyn": 48, "dynam": [44, 45, 51, 52, 54, 58, 95], "dynamic_shadow": [45, 51, 52], "e": [1, 2, 3, 4, 6, 7, 11, 14, 15, 18, 25, 35, 40, 43, 47, 49, 52, 53, 54, 59, 60, 61, 63, 64, 66, 69, 72, 73, 74, 76, 77, 82, 83, 84, 85, 86, 87, 88, 91, 93, 95], "e1": [57, 62], "e2": [7, 57, 62], "e2_rang": [1, 63, 72], "e3": [57, 62], "e_refin": 11, "each": [1, 2, 11, 12, 14, 17, 18, 33, 35, 38, 40, 42, 47, 52, 53, 54, 59, 60, 63, 65, 66, 67, 68, 69, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96], "earli": [78, 83], "earlier": [74, 75], "eas": 14, "easi": [77, 82, 83, 86, 87], "easier": [23, 25, 74, 82, 86], "easiest": 84, "easili": [2, 4, 74], "east": 90, "easy_mp": 83, "easy_run": 83, "echo": [83, 93], "echol": [0, 95], "edg": [47, 50, 51, 53, 54, 59, 60, 73, 75, 76, 88, 97], "edit": [3, 36, 73, 81, 83, 87], "editor": [73, 74, 83], "edmand": [0, 84, 95], "edu": 18, "eec": 11, "effect": [2, 14, 35, 47, 53, 59, 60, 63, 74, 76, 81, 82, 83, 84, 86, 87], "effici": [1, 3, 14], "effort": [0, 81, 83], "eg": 95, "ehrensberg": 95, "ei": 78, "eigen": 84, "eigenvector": 84, "eiger": [48, 76], "eiger16mnov2015": 48, "eighteen": 74, "eisenberg": 95, "either": [0, 1, 2, 4, 24, 40, 44, 47, 48, 51, 52, 53, 58, 59, 60, 63, 68, 70, 73, 74, 79, 82, 86, 87, 96], "el": 95, "electron": [11, 21, 47, 52, 53, 73, 74, 75, 90, 95, 97], "element": [2, 14, 15, 18, 25, 40, 76, 78, 82, 83, 84, 86, 87], "elev": 84, "elif": 95, "elimin": [11, 68, 76], "eliminate_sys_abs": 68, "ellips": 75, "ellipsoid": [41, 51, 54, 58, 96], "ellipt": 75, "els": [1, 6, 23, 87], "elsewher": 84, "eman": [53, 59, 60], "emax": [15, 43, 63, 72], "emb": 62, "emphasi": 97, "emploi": [14, 78], "employe": 90, "empti": [24, 33, 48], "en": 18, "enabl": [0, 4, 38, 45, 51, 52, 54, 83, 84, 94, 95, 96, 97], "enantiomorph": 84, "encapsul": [21, 23, 25], "encod": 3, "encount": [78, 79, 83], "encourag": 1, "end": [2, 14, 15, 33, 46, 47, 54, 59, 63, 69, 72, 73, 74, 77, 78, 81, 82, 83, 84, 86, 87, 88, 90, 96, 98], "endeavour": 90, "endors": 92, "energi": [0, 35, 90], "enforc": [53, 74, 77, 82, 83, 86], "eng": 73, "engin": [14, 18, 40, 44, 53, 59, 60, 63, 72], "enhanc": 1, "enough": [53, 59, 60, 73, 78, 81, 83, 93], "ensur": [2, 14, 23, 26, 38, 40, 63, 74, 81, 82, 83, 86, 87, 88], "enter": [3, 7, 14, 63, 74, 87], "enthusiast": 76, "entir": [4, 47, 73, 77, 88], "entri": [2, 77], "enumer": 83, "env": [4, 83], "environ": [0, 4, 48, 75, 79, 81, 91], "eof": [52, 75, 86], "ep": [18, 53], "epilog": [6, 33], "epoch": [3, 29, 52, 82, 86], "epsilon": [11, 18, 53], "eqnarrai": 2, "equal": [16, 18, 35, 43, 47, 53, 54, 56, 59, 60, 63, 66, 72, 77, 84], "equat": [14, 40], "equip": 2, "equival": [2, 14, 15, 49, 52, 60, 63, 68, 78, 82, 84, 86, 87], "era": 97, "erf": 84, "eriksson": 95, "erko": 95, "errant": 83, "error": [1, 9, 14, 15, 18, 35, 40, 44, 52, 53, 59, 60, 63, 70, 72, 74, 75, 82, 84, 86, 87, 93], "error_model": [1, 15, 63], "error_model_group": [1, 63], "error_param": 15, "ersatz": 44, "esd": [14, 88], "especi": [11, 53, 73, 84, 86, 87], "essenc": 4, "essenti": [2, 14, 73, 76, 82, 83, 86, 87], "est_standard_dev": 4, "estim": [1, 11, 14, 18, 40, 42, 43, 48, 49, 53, 54, 59, 60, 63, 67, 70, 72, 76, 79, 82, 84, 86, 87, 88], "estimate_gain": 71, "estimate_global_threshold": [31, 32], "estimate_resolut": [71, 72, 76, 84], "estimate_tim": 33, "et": [11, 64, 72, 73, 79, 84], "etc": [2, 18, 33, 59, 70, 76, 79, 84, 88, 96], "euclidean": 53, "euler": 39, "eval": 97, "evalccd": 44, "evalu": [11, 14, 15, 46, 53, 76, 95], "evan": [0, 11, 18, 69, 83, 95, 97, 98], "even": [1, 2, 14, 44, 74, 77, 78, 82, 83, 84, 87, 92], "evenli": 11, "event": 92, "eventu": [82, 86, 87], "ever": [53, 78, 97], "everi": [14, 38, 47, 51, 53, 54, 55, 59, 60, 63, 66, 69, 72, 76, 81, 82, 83, 86, 87], "everyth": [7, 21, 23, 25, 74, 76], "everywher": [23, 78], "evid": [73, 74, 76, 77], "evolv": 0, "ewald": [14, 53, 59, 60, 74], "ewald_proximal_volume_max": 53, "ewald_proximity_resolution_cutoff": 53, "exactli": [6, 23, 74, 78, 81], "examin": [11, 38, 54, 73], "exampl": [1, 2, 3, 4, 6, 7, 8, 21, 23, 34, 35, 36, 37, 38, 39, 41, 42, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 94, 96], "exce": [14, 52], "excel": 78, "except": [4, 11, 33, 47, 53, 59, 60, 74, 75], "excis": [53, 59, 60], "excit": 44, "excitation_error_cutoff": 44, "exclud": [1, 14, 15, 33, 44, 47, 49, 53, 54, 59, 60, 63, 66, 69, 72, 74, 76, 77, 82, 83, 84, 86], "exclude_dataset": [1, 63, 76], "exclude_imag": [1, 47, 54, 63, 69, 72, 73, 84], "exclude_images_multipl": [47, 54, 63, 66, 69, 72], "exclude_single_crystal_clust": 38, "exclus": [1, 47, 51, 54, 63, 66, 69, 72, 76, 84], "execut": [16, 74, 83], "executor": [12, 19], "executorwrapp": 12, "exemplari": 92, "exercis": [77, 78], "exhibit": 83, "exist": [0, 1, 4, 9, 15, 18, 23, 52, 72, 82, 83, 84, 86, 87, 97], "exit": [3, 83], "exocytosi": 95, "exp": [35, 47, 54, 63, 69, 72, 73, 74, 78, 81, 82, 83, 85, 86], "exp_no": 33, "expand": [2, 68, 75], "expand_to_p1": 68, "expect": [2, 7, 14, 18, 35, 44, 63, 73, 74, 75, 77, 78, 81, 82, 83, 84, 86, 87, 97], "expected_cc": 18, "expens": [14, 87], "experi": [0, 1, 2, 4, 5, 11, 12, 14, 15, 16, 17, 18, 23, 24, 30, 31, 33, 35, 36, 37, 38, 40, 41, 44, 46, 47, 50, 52, 53, 54, 55, 58, 59, 60, 61, 63, 64, 65, 66, 69, 70, 72, 73, 74, 75, 78, 81, 82, 83, 84, 85, 86, 87, 88, 90, 93, 95, 96, 97], "experienc": 78, "experiment": [2, 3, 4, 7, 11, 26, 38, 52, 53, 59, 60, 61, 63, 64, 66, 70, 74, 75, 76, 77, 82, 84, 86, 87, 88, 89, 96, 97], "experiment_data": 6, "experiment_file_object_list": 33, "experiment_identifi": 33, "experiment_list": [3, 4, 11, 27, 30, 32, 33, 83], "experiment_list_for_cryst": 11, "experiment_typ": 14, "experimentlist": [3, 4, 11, 14, 16, 24, 27, 33, 83], "experimentlistfactori": [24, 27], "experiments_": [88, 93], "experiments_0": [38, 40, 84, 88], "experiments_1": [38, 40, 81, 84, 88], "experiments_2": [40, 84, 88], "experiments_3": [40, 84, 88], "experiments_and_reflect": 83, "experiments_filenam": [38, 66], "expert": [0, 87], "expert_level": [7, 38, 40, 41, 43, 45, 46, 47, 50, 51, 52, 53, 54, 55, 57, 59, 60, 61, 62, 63, 66, 69, 70, 72, 82, 86], "explain": [40, 74, 76, 84], "explan": 9, "explicit": [2, 53, 59, 60, 82, 86, 87], "explicitli": [1, 54, 74], "explor": [2, 74, 78, 82, 84, 87, 95], "exponenti": 15, "export": [1, 18, 30, 33, 45, 63, 71, 74, 75, 81, 83, 84, 89], "export_al": 83, "export_as_json": 11, "export_bitmap": 71, "export_mtz": [32, 33, 83], "export_reflect": 11, "export_text": [32, 33], "expos": 14, "exposur": [46, 52, 82, 86, 87], "exposure_tim": [3, 29], "express": [2, 46, 88, 92], "expt": [1, 3, 6, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 88, 93, 96], "expt_path": 83, "extend": [5, 11, 24, 33, 41, 51, 54, 58, 72, 78, 81, 82, 86, 87, 94], "extens": [1, 4, 32, 41, 45, 47, 51, 54, 58, 59, 70, 74, 75, 90, 94], "extent": [1, 72, 82, 84, 86], "extern": [4, 14, 16, 62, 74, 87], "external_deltapsi": [53, 59, 60], "external_depend": 62, "external_lookup": 26, "externaldelpsiweightingstrategi": [14, 19], "externallookup": [26, 27], "externallookupitembool": [26, 27], "externallookupitemdoubl": [26, 27], "extra": [14, 30, 48, 53, 59, 60, 81, 87], "extra_filenam": 30, "extract": [11, 16, 33, 78, 82, 83, 85, 86, 87], "extract_reference_intens": [18, 19], "extractpixelsfromimag": [16, 19], "extractpixelsfromimage2dnoshoebox": [16, 19], "extractspot": [16, 19], "extractspotsparalleltask": [16, 19], "extrapol": 52, "extrapolate_scan": 52, "extrem": [53, 59, 60, 62, 78, 81, 83, 84, 95, 97], "ey": [82, 86, 87], "f": [2, 6, 18, 74, 75, 76, 82, 84, 85, 86, 87, 88], "fabl": 95, "face": [77, 81, 90], "facil": [44, 83, 84, 97], "facilit": [0, 97], "fact": [40, 74, 75, 77, 78, 81, 83], "factor": [1, 3, 14, 15, 35, 40, 53, 63, 64, 66, 72, 73, 77, 79, 81, 82, 83, 84, 85, 86, 87, 88], "factori": [4, 14, 16, 21, 23, 25, 26, 28, 29, 33, 81], "faculti": 18, "fail": [14, 53, 59, 60, 73, 74, 82, 83, 85, 86, 88, 93], "fail_on_bad_index": [41, 51, 54, 58], "failed_during_profile_fit": 46, "failed_during_summ": 46, "failur": [53, 59, 60, 72, 78], "fair": 83, "fairli": [73, 74, 75, 78, 81, 82, 86, 87], "fall": [38, 47, 50, 51, 54, 72, 74, 81, 82, 86], "falloff": [38, 43, 54, 84], "fals": [1, 4, 6, 11, 14, 15, 16, 17, 22, 23, 24, 26, 31, 33, 37, 38, 40, 41, 43, 44, 45, 46, 47, 48, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 63, 64, 65, 67, 68, 70, 72, 73, 74, 75, 82, 83], "famili": 32, "familiar": [83, 87], "familiaris": 1, "far": [76, 81, 83, 88], "fast": [23, 33, 38, 47, 50, 51, 52, 53, 59, 60, 73, 74, 75, 83, 86, 95], "fast_axi": [3, 23, 38, 52, 75, 82, 86], "fast_axis_toler": [23, 24], "fast_direct": 23, "fast_slow_beam_centr": [52, 73], "faster": [47, 50, 51, 53, 59, 60], "favour": [74, 77, 82, 86, 87], "fe": 95, "feasibl": 83, "featur": [73, 74, 75, 77, 83, 90], "feb": 95, "februari": 99, "fed": 73, "federici": 95, "feed": 83, "feedback": 49, "feel": [74, 82, 83, 86], "fel": 97, "femtosecond": [74, 95], "feng": 95, "fetch": 51, "few": [50, 53, 59, 60, 73, 74, 77, 78, 81, 83, 84, 96], "fewer": [38, 74, 96], "fft": [11, 53, 74, 82, 83, 86, 87], "fft1d": [4, 11, 53, 82, 83, 86, 96], "fft3d": [4, 11, 53, 87], "fi": 75, "field": [0, 11, 33, 87, 97], "fifth": 87, "fifti": 73, "figsiz": 11, "figur": [73, 74, 78, 81, 83], "file": [1, 4, 7, 8, 21, 23, 24, 25, 29, 30, 33, 35, 36, 37, 38, 40, 41, 42, 43, 44, 45, 46, 47, 48, 50, 51, 52, 53, 54, 55, 58, 59, 60, 61, 62, 63, 69, 70, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 91, 93, 96], "file_nam": [11, 48], "filenam": [11, 14, 16, 18, 24, 26, 29, 30, 33, 36, 38, 41, 44, 46, 47, 50, 52, 53, 54, 58, 59, 60, 61, 63, 66, 68, 69, 70, 74, 76, 83, 87, 96], "filename_object_list": 33, "filename_or_data": 16, "filename_or_non": [27, 30], "filename_prefix": 44, "filename_to_absolut": [27, 30], "filepath": 63, "fill": 45, "filter": [11, 12, 14, 15, 16, 18, 38, 40, 41, 44, 45, 46, 47, 48, 50, 51, 53, 54, 58, 63, 70, 72, 74, 75, 82, 84, 85, 86, 87], "filter_by_likelihood": 11, "filter_by_n_index": 11, "filter_by_volum": 11, "filter_doubled_cel": 11, "filter_ic": [11, 53], "filter_ice_r": [33, 44], "filter_integrated_centroid": 70, "filter_known_symmetri": 11, "filter_ob": 14, "filter_overlap": [11, 53], "filter_reflect": 71, "filter_similar_orient": 11, "filter_spot": 16, "filterrunn": [16, 19], "final": [1, 12, 14, 59, 63, 70, 72, 73, 74, 76, 81, 82, 83, 84, 86, 87, 88, 90], "final_list_of_fil": 83, "final_outlier_arrai": 15, "finalis": [12, 14], "finalize_reflect": 12, "find": [1, 4, 9, 11, 16, 24, 38, 42, 45, 47, 50, 51, 52, 53, 54, 64, 76, 77, 81, 83, 85, 91, 93], "find_basis_vector": [4, 11], "find_crystal_model": [4, 11], "find_lattic": 11, "find_matching_symmetri": 11, "find_max_cel": 11, "find_rotation_axi": 74, "find_spot": [3, 16, 48, 49, 53, 67, 71, 73, 74, 75, 76, 78, 81, 82, 83, 85, 86, 87, 88, 96], "find_spots_cli": 49, "find_spots_serv": 71, "finder": [16, 82, 86], "fine": [53, 59, 60, 74, 81, 82, 86, 87, 93, 97], "finish": [12, 33, 63, 82, 86, 87], "finit": 18, "firefox": [76, 84], "first": [1, 4, 12, 15, 18, 23, 25, 26, 34, 38, 40, 45, 46, 52, 53, 54, 56, 59, 60, 68, 70, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 95, 97], "firstli": 77, "fischetti": 95, "fit": [3, 12, 35, 41, 43, 51, 54, 58, 60, 63, 70, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 92], "fit_method": [41, 51, 54, 58], "fit_profil": 12, "fix": [2, 14, 15, 25, 35, 38, 41, 51, 52, 53, 54, 58, 59, 60, 63, 73, 74, 75, 77, 78, 79, 81, 82, 83, 86], "fix_initi": 63, "fix_initial_paramet": 15, "fix_list": [53, 59, 60, 75], "fixed_compon": 15, "fixed_rot": [3, 25, 38, 52], "fixed_rotation_matrix": 25, "fixed_rotation_toler": [24, 25], "flag": [3, 6, 14, 15, 16, 44, 46, 53, 54, 59, 60, 65, 70, 72, 82, 83, 86], "flag_express": 46, "flag_filt": 44, "flaig": 95, "flat": [12, 35, 47, 74, 82, 86, 87], "flatten": [12, 18, 33], "flatten_experi": [6, 32, 33], "flatten_reflect": [6, 32, 33], "flex": [3, 4, 11, 14, 15, 83], "flight": [16, 24, 94], "float": [4, 10, 11, 14, 15, 18, 21, 22, 23, 25, 33, 35, 37, 38, 40, 41, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 62, 63, 64, 66, 68, 69, 70, 72], "flood_fil": 53, "floor": 2, "flueckig": 74, "flux": [21, 52, 82, 86], "fn": 11, "foadi": 83, "focu": [73, 76, 85, 90, 94], "focuss": 76, "fold": 63, "folder": [48, 76, 84, 86, 87], "follow": [0, 1, 2, 3, 6, 7, 9, 14, 18, 40, 43, 46, 48, 52, 53, 54, 64, 66, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 91, 92, 93, 96, 97], "font_siz": 68, "fontsiz": 45, "footprint": 73, "for_a_sampl": 18, "forc": [14, 16, 17, 38, 41, 44, 47, 51, 53, 54, 58, 59, 60, 73, 78, 82], "force_2d": 47, "force_stat": [17, 41, 51, 53, 54, 58, 59, 60, 73, 75], "force_static_model": [33, 44], "foreground": [31, 54, 74, 82, 85, 86], "foreground_background": 54, "foreground_foreground": 54, "foreseen": 78, "forgiv": 81, "fork": [24, 94], "form": [2, 7, 14, 30, 43, 47, 53, 54, 59, 60, 74, 76, 77, 78, 82, 83, 86, 87, 92], "formal": 97, "format": [1, 2, 3, 18, 23, 24, 26, 30, 33, 44, 45, 47, 51, 52, 54, 55, 57, 63, 69, 72, 73, 74, 75, 79, 81, 82, 83, 85, 86, 87, 88, 96, 98], "format_class": 26, "format_epilog": 33, "format_help": 33, "format_kwarg": [24, 26, 33], "formatbaseclass1": 4, "formatbaseclass2": 4, "formatbruk": 4, "formatbrukerfixedchi": 4, "formatbrukerphotonii": 4, "formatcbfminipilatu": [4, 82, 83], "formatcbfminipilatusdls6msn100": [85, 86], "formatcbfminipilatusmybeamlin": 4, "formatcbfminitimepix": 75, "formatmyclass": 4, "formatsmvcetad_tui": 73, "formatsmvtimepix_su_516x516": 74, "formatt": 33, "formatter_class": 33, "formula": [14, 18, 40, 72, 82, 84, 86], "fortran": 95, "forum": 97, "forward": [40, 54, 76], "found": [2, 4, 6, 11, 16, 40, 47, 48, 49, 52, 53, 63, 73, 74, 75, 78, 79, 81, 82, 83, 84, 85, 86, 87, 95, 96], "four": [1, 73, 76, 84, 88], "fourier": [53, 69], "fourth": 84, "fpercent": 33, "frac": [2, 35, 81, 82, 86, 87], "frac_binsize_cutoff": 14, "fraction": [2, 3, 11, 16, 21, 38, 41, 46, 47, 51, 52, 53, 54, 58, 59, 60, 72, 82, 84, 86], "fraction_index": 11, "fraction_of_bin_s": [53, 59, 60], "fractionalis": 2, "fragment": 82, "frame": [3, 11, 12, 14, 21, 22, 23, 25, 33, 34, 35, 44, 47, 48, 54, 63, 68, 69, 72, 75, 76, 82, 86, 87, 97], "frame0": 12, "frame1": 12, "frame_hist": [12, 19], "frame_numb": 48, "frame_value_": 75, "frame_value_018": 75, "framework": [0, 2, 4, 6, 90, 95], "frank": 97, "fraser": 95, "free": [63, 72, 73, 74, 77, 79, 82, 83, 86, 90, 95, 97], "free_set_offset": 63, "free_set_percentag": 63, "freedom": [2, 40, 53, 59, 60, 72, 81], "freer_flag": 84, "freerflag": 73, "french": 84, "frequenc": [11, 53], "frequent": 7, "fresh": 87, "friedel": [73, 78, 82, 86], "from": [0, 1, 2, 3, 4, 6, 7, 9, 11, 14, 15, 16, 18, 21, 22, 23, 24, 25, 26, 29, 30, 33, 35, 38, 40, 41, 44, 45, 47, 48, 50, 51, 52, 53, 54, 55, 57, 59, 60, 61, 62, 63, 64, 66, 69, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 91, 92, 93, 94, 95, 96, 97, 98], "from_arg": 24, "from_data": [4, 15], "from_dict": [4, 15, 21, 22, 23, 24, 25, 28, 29, 31], "from_fil": [3, 24, 83], "from_filenam": 24, "from_imageset": 26, "from_imageset_and_cryst": 24, "from_json": 24, "from_json_fil": [14, 24], "from_mosflm_matrix": 22, "from_paramet": [11, 16], "from_parameters_and_experi": 14, "from_parameters_data_experi": 14, "from_parameters_reflections_experi": 14, "from_phil": [12, 21, 23, 25, 29], "from_pickle_fil": 24, "from_sequence_and_cryst": 24, "from_serialized_format": 24, "from_stills_and_cryst": 24, "from_sunbird": 48, "from_templ": [24, 26], "from_xd": 24, "front": 73, "fry": 95, "fuent": [0, 95, 98], "full": [1, 3, 4, 14, 21, 23, 74, 76, 81, 82, 83, 86, 87, 96], "full_matrix": [1, 63], "full_matrix_engin": 63, "full_matrix_max_iter": [1, 63], "fuller_kapton": 54, "fulli": [0, 2, 44, 46, 54, 74, 81, 82, 85, 86], "fully_buff": 83, "func": 83, "function": [1, 2, 7, 11, 12, 14, 15, 16, 18, 26, 36, 40, 43, 53, 54, 59, 60, 63, 74, 81, 82, 83, 84, 86, 87, 94], "fund": [0, 94], "fundament": [2, 14], "further": [0, 1, 4, 7, 15, 48, 63, 72, 77, 81, 82, 85, 86, 87, 88, 91, 96], "furthest": 84, "futur": [94, 97, 98], "g": [0, 1, 2, 3, 6, 7, 11, 14, 15, 18, 30, 40, 47, 49, 52, 53, 54, 59, 60, 61, 63, 64, 66, 69, 72, 73, 76, 77, 79, 82, 83, 84, 85, 86, 88, 91, 95], "g06727c3": 75, "g5dd0b6cbf": [], "g73f70f18": 79, "g9af1ec126": [40, 82, 84, 86], "gain": [0, 23, 26, 33, 42, 45, 47, 51, 52, 73, 74, 75, 78, 82, 86], "gain_map": [42, 47], "gaithersburg": 35, "gallo": 95, "gambin": 74, "gamma": [2, 18, 40, 84, 88], "ganesh": 73, "garib": [0, 98], "gaug": 84, "gauss": 14, "gaussian": [15, 31, 41, 47, 51, 54, 58, 82, 86, 87], "gaussian_r": [4, 31, 41, 51, 54, 58], "gaussian_rs_profile_model_ext": [4, 31], "gaussianrsprofilemodelext": [31, 32], "gaussnewton": [53, 59, 60, 63], "gaussnewtoniter": [14, 19], "gb": [79, 81, 82, 86], "gec9ae4af3": [], "gemmi": 33, "gener": [0, 1, 3, 4, 11, 12, 18, 24, 25, 29, 33, 35, 45, 46, 47, 50, 51, 52, 53, 54, 56, 57, 60, 62, 63, 66, 67, 68, 72, 74, 75, 76, 81, 82, 83, 84, 85, 86, 87, 88, 90, 94, 96, 97], "generalis": 0, "generate_distortion_map": 75, "generate_from_phil": 23, "generate_mask": [71, 73, 75], "generate_phil_scop": [12, 16, 19], "genuin": 40, "geometri": [2, 3, 4, 11, 33, 44, 52, 53, 59, 60, 66, 74, 75, 77, 80, 81, 82, 86, 87, 88, 95, 96, 98], "gerard": [0, 97], "gerstel": [0, 95], "gerstman": 18, "get": [1, 8, 14, 16, 17, 23, 24, 25, 26, 29, 30, 33, 54, 74, 76, 81, 82, 83, 84, 86, 87], "get_a_as_sqr": 22, "get_a_inverse_as_sqr": 22, "get_accepted_refs_s": 14, "get_alpha_angl": 25, "get_angl": 25, "get_angle_from_array_index": 6, "get_array_rang": [6, 26], "get_ax": 25, "get_beam": [26, 30], "get_cbf_head": 4, "get_centroid_analys": 14, "get_corrected_data": 26, "get_correlation_matrix_for_step": 14, "get_crystal_symmetri": 22, "get_data": [26, 33], "get_detector": [26, 30], "get_detectorbas": 26, "get_direct": 25, "get_domain_size_ang": 22, "get_elapsed_tim": 33, "get_entri": [32, 33], "get_experi": 14, "get_fixed_rot": [6, 25], "get_flag": 6, "get_format_class": 26, "get_free_reflect": 14, "get_gain": 26, "get_goniomet": [26, 30], "get_grid_s": 26, "get_half_mosaicity_deg": 22, "get_image_identifi": 26, "get_index": 14, "get_inverse_ub_matrix_from_xparm": [32, 33], "get_kappa_angl": 25, "get_kappa_axi": 25, "get_mask": 26, "get_master_path": 26, "get_match": 14, "get_max_inscribed_resolut": 23, "get_max_resolut": 23, "get_mosa": 22, "get_nam": [23, 25], "get_nrow": 14, "get_num_match": 14, "get_num_matches_for_experi": 14, "get_num_matches_for_panel": 14, "get_num_scan_point": 25, "get_num_step": 14, "get_ob": 14, "get_omega_angl": 25, "get_omega_axi": 25, "get_panel_intersect": 23, "get_param": 26, "get_param_report": 14, "get_parameter_correlation_matrix": 14, "get_path": 26, "get_pedest": 26, "get_phi_angl": 25, "get_phi_axi": 25, "get_process": 83, "get_raw_data": 26, "get_raw_data_from_imageset": 55, "get_ray_intersect": 23, "get_rotation_axi": 25, "get_rotation_axis_datum": [6, 25], "get_s0": 6, "get_sample_s": 14, "get_scan": [26, 30], "get_scan_axi": 25, "get_setting_rot": [6, 25], "get_setting_rotation_at_scan_point": 25, "get_shared_compon": 15, "get_space_group_type_from_xparm": [32, 33], "get_spectrum": 26, "get_templ": [26, 30, 83], "get_vendor": 26, "get_vendortyp": 26, "get_wavelength": 6, "get_weighting_strategy_overrid": 14, "getcwd": 83, "getlogg": 83, "gevorkov": 11, "gf37b0db7a": 79, "gf88516da7": 85, "ghani": 83, "giacovazzo": 2, "gildea": [0, 11, 18, 40, 72, 84, 95], "gingeri": 95, "ginn": 95, "github": [9, 75, 82, 84, 86, 90, 91], "githubusercont": [9, 48, 73, 75], "give": [1, 2, 7, 14, 18, 40, 45, 46, 53, 59, 60, 61, 66, 69, 72, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 96], "given": [0, 1, 2, 4, 11, 14, 15, 16, 17, 18, 22, 23, 25, 28, 30, 35, 39, 40, 41, 44, 46, 47, 49, 51, 52, 53, 54, 55, 58, 62, 63, 64, 67, 68, 69, 72, 74, 78, 82, 83, 84, 86, 87, 96], "gj": 95, "glacio": 73, "glatzel": 95, "gleb": 0, "glm": 54, "global": [47, 53, 54, 59, 60, 64, 74, 83], "global_threshold": [45, 47, 51, 75], "globular": [82, 86, 87], "gltbx": 33, "glu": 9, "gl\u00f6ckner": 95, "gm117126": [0, 90], "gmail": 79, "gmodel": 54, "gmt": 85, "gn": [63, 95], "go": [47, 54, 63, 69, 72, 73, 74, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88], "goal": [2, 90], "goe": 73, "goldschmidt": 95, "gon_kappa": 86, "gon_omega": 86, "gon_phi": 86, "gone": [82, 86, 87], "gonen": 95, "gonimomet": 2, "goniomet": [3, 4, 6, 24, 26, 27, 32, 34, 35, 38, 52, 53, 59, 60, 74, 75, 78, 82, 83, 86, 93, 95], "goniometerbas": 25, "goniometercomparison": [24, 27], "goniometerfactori": [25, 27], "goniometershadowmask": 26, "goniostat": 2, "gonz\u00e1lez": 95, "good": [11, 38, 63, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 92], "good_result": 83, "got": 83, "gov": [9, 35, 48], "gpu": 97, "grad": 18, "gradient": [14, 18, 53, 59, 60], "gradient_calculation_blocks": [14, 53, 59, 60], "gradient_cutoff": [16, 47], "gradient_threshold": 14, "graem": [0, 97, 98], "grain": [53, 59, 60], "grant": [0, 90], "graph": [53, 56, 59, 60, 73, 87], "graph_verbos": 11, "graphic": [76, 82, 86, 87], "grate": 0, "grayscal": 51, "great": [73, 77, 87], "greater": [18, 41, 47, 51, 54, 58, 63, 64, 78, 83, 96], "greatest": [11, 81], "greatli": [0, 90, 97], "green": [82, 86, 87], "grep": 83, "greyscal": 45, "grid": [1, 11, 37, 41, 49, 51, 52, 53, 54, 58, 63, 64, 78, 81, 82, 86, 87, 96], "grid_h": 37, "grid_k": 37, "grid_l": 37, "grid_method": [41, 51, 54, 58], "grid_search_scop": 53, "grid_siz": [26, 41, 51, 52, 54, 58, 62, 81], "gridsiz": 68, "grime": 95, "gross": [0, 2, 11, 95], "grossli": 78, "ground": 0, "group": [1, 2, 4, 11, 15, 18, 22, 23, 33, 37, 40, 43, 45, 46, 47, 50, 51, 52, 53, 59, 60, 61, 63, 69, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96], "group_info": 11, "group_siz": [63, 72, 74], "groups_cach": 11, "grow": [73, 76, 77], "gruen": [75, 95], "guarante": [54, 87, 88], "guenther": 95, "guess": 72, "gui": 51, "guid": [9, 63], "guidanc": 0, "gul": 95, "gwyndaf": [0, 83, 97, 98], "gz": [44, 48, 86, 88, 91], "gzip": 75, "h": [0, 2, 35, 37, 53, 61, 73, 74, 75, 77, 78, 82, 83, 84, 85, 86, 95], "h5": 48, "ha": [1, 4, 7, 11, 14, 15, 21, 23, 25, 29, 35, 40, 53, 59, 60, 73, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 90, 93, 96, 97], "had": [73, 77, 81, 82, 83, 84, 86, 87], "half": [40, 43, 53, 72, 74, 77, 79, 82, 84, 86, 87, 88], "half_dataset": [33, 43, 72], "half_mosaicity_deg": 22, "half_mosaicity_toler": 22, "hall": [81, 95], "hammerslei": 2, "han": 95, "hand": 36, "handi": 9, "handl": [2, 16, 23, 24, 25, 29, 33, 74, 75, 76, 83, 84, 85, 98], "happen": [73, 78, 82, 85, 86, 87], "happi": [82, 83, 85, 86, 87], "happili": 83, "hardli": 74, "hardwar": 0, "harmon": [1, 63, 72, 88], "harri": [0, 98], "has_dynamic_mask": 26, "has_projection_2d": 23, "has_single_file_read": 26, "hassanul": 83, "hat": 35, "hattn": [0, 95], "have": [0, 1, 2, 4, 7, 18, 25, 35, 36, 40, 42, 44, 47, 52, 53, 54, 59, 60, 63, 71, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96, 97], "hcluster": 53, "hdf5": 24, "head": [32, 33], "header": [4, 9, 23, 26, 29, 52, 73, 74, 77, 78, 83, 85], "health": [0, 90], "hear": 79, "heart": 0, "heat": 87, "heatmap": [45, 51, 62], "heavi": [0, 63, 76], "hedman": 95, "heed": 78, "height": [47, 53, 54, 59, 60, 84], "held": [0, 2], "hellmich": 95, "help": [1, 4, 6, 18, 21, 24, 29, 33, 35, 36, 37, 38, 40, 41, 42, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 68, 69, 70, 72, 73, 74, 76, 78, 81, 82, 86, 87, 88, 96, 97], "help_messag": 6, "helper": 33, "hemispher": 11, "henc": [29, 35, 82, 84], "hennessi": 73, "here": [0, 2, 6, 14, 40, 48, 52, 57, 62, 63, 71, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 93, 94, 95], "heurist": 87, "hidden": [14, 81], "hide": [40, 82, 84, 86], "hieararchy_level": 81, "hierarch": [38, 40, 53, 59, 60, 72, 81], "hierarchi": [4, 23, 52, 53, 59, 60, 75, 81], "hierarchy_level": [53, 59, 60, 81], "high": [0, 1, 11, 18, 35, 37, 38, 40, 46, 47, 48, 50, 51, 53, 54, 63, 72, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 96, 97], "higher": [1, 4, 11, 63, 73, 74, 78, 82, 83, 84, 86, 87], "highest": [1, 11, 38, 40, 54, 61, 78, 81, 82, 84, 85, 86, 87], "highli": [74, 83, 97], "highlight": [76, 87], "hilgart": 95, "hint": [73, 76, 78, 87], "hist": [12, 19], "histogram": [12, 53, 74, 76, 82, 85, 86], "histogram_bin": [11, 53], "histor": [9, 97], "histori": [14, 53, 59, 60, 84, 85, 87], "hj": 95, "hkl": [2, 17, 30, 39, 44, 68, 78, 88], "hkl_base": 84, "hkl_limit": 68, "hkl_offset": [11, 61, 78], "hkl_toler": 53, "hklf": [44, 73], "hklin": [75, 86], "hklout": [33, 44, 73, 75, 81, 83, 86, 88, 93], "hm": 95, "hodgson": 95, "hold": 2, "holder": 92, "hollenbeck": 95, "holm": 74, "holton": 95, "home": [7, 75], "hopefulli": [4, 83], "horizont": 2, "horrel": 95, "host": [48, 49, 79], "hostnam": 49, "hot": 47, "hot_mask": [16, 47], "hot_mask_prefix": [16, 47], "hour": 48, "how": [1, 4, 6, 11, 14, 15, 47, 53, 57, 59, 60, 62, 73, 74, 76, 78, 81, 82, 83, 84, 86, 87, 88, 95, 96, 97], "howev": [0, 1, 2, 14, 41, 42, 44, 54, 61, 68, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 92, 93, 96], "hp": [78, 95], "ht": 95, "html": [1, 40, 43, 48, 62, 63, 69, 73, 74, 76, 84, 85, 96], "http": [9, 11, 18, 35, 47, 48, 53, 59, 60, 73, 75, 82, 88, 91], "httpd": 48, "hu": 83, "hubbel": 35, "human": 3, "hundr": 76, "hunter": 74, "huw": 0, "hw": 95, "hybrid": 0, "hypothesi": 87, "i": [0, 1, 2, 3, 4, 6, 7, 9, 11, 14, 15, 16, 18, 21, 22, 23, 24, 25, 26, 29, 33, 34, 35, 36, 38, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 66, 68, 69, 70, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 92, 93, 94, 95, 96, 97], "i04": [82, 85, 86, 87], "i04_thaumatin": 79, "i19": 35, "i2": [18, 40, 60, 69, 72, 74, 82], "i23": 40, "i3_1_0001": 48, "i7": [81, 83], "i_mean_over_sigma_mean": [43, 72], "i_over_sigma": 54, "ian": 0, "ibg": [74, 81, 82, 85, 86], "ibrahim": 95, "ic": [44, 45, 46, 47, 49, 50, 51, 53, 54, 81, 82, 84, 86, 95], "ice_r": [45, 46, 47, 50, 51, 54], "id": [1, 3, 16, 33, 44, 46, 52, 53, 59, 60, 63, 66, 67, 72, 73, 74, 78, 82, 83, 84, 85, 86, 95], "id_": [4, 15], "idea": [0, 76], "ideal": [4, 33, 74, 77, 88, 93], "ident": [6, 40, 60, 76, 82, 86, 88, 93], "identif": [53, 59, 60], "identifi": [4, 11, 23, 24, 26, 33, 40, 42, 47, 52, 53, 54, 56, 59, 60, 63, 65, 69, 72, 76, 78, 82, 83, 84, 86, 87, 88], "identifier_typ": 52, "identify_outli": 11, "idiomat": 29, "idxref": 30, "iexp": [14, 84], "ignor": [11, 26, 33, 52, 53, 58, 59, 60, 77, 84], "ignore_shadow": 58, "ignore_trusted_rang": 23, "ignore_unhandl": [33, 52], "ignore_unknown": 26, "ih": [15, 63, 82, 84, 86], "ih_tabl": 15, "ihtabl": 15, "ii": 95, "iii": 11, "ij": 18, "illumin": [82, 84, 86, 87], "illustr": [35, 76, 97], "im": [82, 86], "imag": [1, 2, 3, 4, 6, 11, 12, 14, 15, 16, 23, 24, 26, 29, 30, 31, 33, 38, 41, 42, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 58, 59, 60, 63, 64, 65, 66, 67, 68, 69, 72, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 89, 95, 96, 97], "image1": 47, "image_": [52, 55, 65], "image_0001": 49, "image_1": 52, "image_1_": 52, "image_2": 52, "image_2_": 52, "image_fil": 4, "image_group": [63, 72, 74], "image_pedest": 73, "image_pl": 23, "image_prefix": 55, "image_rang": [3, 15, 26, 29, 33, 52, 53, 64, 66, 73, 76], "image_s": [3, 23, 52, 82, 86], "image_statist": 65, "image_view": [71, 73, 74, 75, 77, 78, 81, 82, 86, 87], "image_volum": 31, "imagebuff": 26, "imagecif": 95, "imagedoubl": 23, "imagegrid": [26, 27], "imager_00": 47, "imagesequ": [3, 26, 27], "imagesequence_from_dict": [27, 30], "imagesequence_to_dict": [27, 30], "imageset": [3, 6, 16, 24, 27, 30, 32, 36, 45, 47, 53, 54, 55, 73, 74, 82, 83, 85, 86, 87, 93], "imageset_from_anyset": 26, "imageset_from_dict": [27, 30], "imageset_index": 45, "imageset_to_dict": [27, 30], "imagesetdata": [26, 27], "imagesetfactori": [26, 27], "imagesetlazi": [26, 27], "imagin": 78, "imean": [33, 84, 85, 86], "img": [73, 74, 78, 83], "imgcif": [2, 21, 23, 25, 29], "imgcif_h": [21, 23, 25, 29], "imid": [1, 15, 63, 82, 84, 86], "immedi": [54, 75, 81, 86, 87], "impact": [2, 14, 73, 88], "imping": 54, "implement": [4, 14, 15, 16, 18, 23, 26, 31, 40, 41, 51, 54, 58, 69, 78, 84, 90, 95], "impli": [29, 53, 59, 60, 63, 78, 82, 86, 87, 92], "implicit": [2, 54], "import": [1, 2, 3, 4, 6, 7, 24, 32, 33, 42, 47, 53, 64, 67, 71, 74, 76, 77, 81, 83, 89, 96], "important_numb": 4, "importantli": 15, "impos": [75, 85], "improperli": 74, "improv": [1, 63, 73, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96], "in_beam_plan": [53, 59, 60], "in_plac": 24, "in_spindle_plan": [53, 59, 60, 73, 75], "inaccur": 78, "inadequaci": 2, "incid": [35, 53, 59, 60], "incident": 92, "includ": [0, 1, 4, 11, 14, 18, 24, 33, 43, 44, 47, 48, 49, 53, 54, 57, 59, 60, 61, 63, 70, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 90, 92], "include_bad_refer": 54, "include_gui_packag": 33, "include_unused_reflect": 59, "inclus": [14, 40, 46, 47, 53, 54, 59, 60, 63, 69, 72, 74], "incom": [1, 82, 86, 87], "incompat": 2, "incomplet": [73, 74, 75, 88], "inconsist": 53, "incorpor": [81, 98], "incorrect": [37, 53, 74, 77, 78, 88], "incorrectli": [82, 86], "increas": [7, 14, 53, 63, 72, 73, 81, 82, 83, 86, 87, 96, 97], "increasingli": 78, "increment": [18, 63, 74, 76], "inde": [74, 78, 79], "indent": [4, 18, 33], "independ": [41, 53, 59, 60, 76, 81, 82, 84, 86, 87, 88, 96], "index": [2, 3, 6, 14, 15, 17, 18, 19, 26, 32, 37, 40, 41, 44, 45, 46, 47, 51, 54, 58, 59, 60, 61, 62, 63, 64, 68, 70, 71, 72, 76, 77, 79, 81, 83, 84, 89, 93, 95], "index_assign": [7, 53], "index_error": 53, "index_magnitud": 53, "index_qu": 53, "index_reflect": 11, "indexed_1": 68, "indexed_2": 68, "indexed_experi": 11, "indexerknownorient": 11, "indic": [2, 3, 4, 11, 14, 15, 24, 26, 39, 45, 48, 49, 51, 53, 54, 56, 59, 60, 63, 68, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87], "indirect": 92, "individu": [1, 9, 40, 44, 63, 65, 68, 73, 74, 75, 76, 80, 81, 82, 84, 85, 86, 88, 93], "individual_mtz": 83, "individualist": 97, "induc": 84, "industri": 73, "inelast": [47, 74], "infil": 30, "infinit": [2, 14], "inflat": 62, "info": [11, 33, 82, 83, 84, 86], "inform": [1, 2, 7, 9, 14, 15, 18, 23, 26, 41, 44, 47, 48, 52, 53, 59, 60, 70, 72, 73, 76, 77, 82, 83, 84, 85, 86, 87, 88, 90], "infrastructur": 0, "inher": 84, "inherit": [4, 14], "ining": 38, "init": [30, 33], "initi": [1, 11, 12, 14, 15, 21, 23, 25, 29, 53, 54, 59, 60, 63, 72, 74, 75, 77, 80, 82, 83, 86, 87, 97], "initialis": [12, 14, 15, 16, 17, 18, 31, 33, 82, 84, 86], "initialise_smooth_input": 15, "initialize_reflect": 12, "inject": [26, 95], "innov": 92, "inp": [30, 44], "input": [3, 6, 7, 11, 14, 15, 16, 18, 29, 30, 31, 33, 36, 37, 38, 40, 41, 44, 46, 47, 51, 52, 53, 54, 55, 57, 59, 60, 61, 63, 64, 66, 69, 70, 72, 73, 76, 81, 82, 83, 84, 85, 86, 87, 88, 96], "input_filenam": 30, "ins": [44, 73, 88], "insensit": [47, 84], "insert": 4, "insid": [47, 76, 83], "insidi": 78, "insight": [74, 76], "inspect": [1, 4, 59, 70, 76, 78, 81, 82, 83, 85, 86], "inspir": [0, 77, 78, 84], "instal": [4, 8, 32, 33, 48, 71, 73, 75, 77, 78, 79, 80, 81, 83, 84, 85, 86, 87, 88], "install_format": [4, 73], "installer_dir": 33, "instanc": [10, 12, 14, 16, 23, 24, 25, 26, 29, 33, 76, 78], "instanti": [4, 24], "instead": [4, 43, 63, 74, 77, 78, 83, 87], "institut": [0, 35, 90], "instruciton": 44, "instruct": [9, 44, 74, 78, 87, 91, 93, 95], "instrument": [44, 81, 94], "instrument_nam": 44, "instrument_short_nam": 44, "insu6_1_mast": 48, "int": [2, 11, 12, 14, 15, 16, 18, 23, 24, 25, 26, 33, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "integ": [2, 53, 66, 83, 84, 85], "integr": [1, 3, 15, 19, 30, 32, 35, 40, 41, 44, 46, 47, 50, 51, 56, 60, 61, 62, 63, 66, 69, 70, 71, 72, 76, 77, 78, 79, 81, 83, 84, 89, 93, 94, 95, 97, 98], "integrate_all_reflect": 54, "integrated_": [75, 83, 93], "integrated_0": 96, "integrated_1": [72, 75, 88, 96], "integrated_2": [63, 72, 75, 88], "integrated_3": [75, 88], "integrated_4": [75, 88], "integrated_5": 75, "integrated_6": 75, "integrated_7": 75, "integrated_data": 33, "integrated_experi": 75, "integrated_fil": 84, "integrated_prf": 44, "integrated_sum": 44, "integrator2d": [12, 19], "integrator3d": [12, 19], "integrator3dthread": [12, 19], "integratorexecutor": [12, 19], "integratorflat3d": [12, 19], "integratorsingle2d": [12, 19], "integratorstil": [12, 19], "intellectu": 0, "intellig": 33, "intend": [7, 35, 44, 49, 53, 59], "intens": [0, 1, 3, 11, 15, 18, 33, 35, 37, 40, 43, 44, 46, 47, 49, 53, 54, 61, 63, 72, 73, 74, 77, 78, 82, 83, 84, 85, 86, 87, 88, 94, 96, 97], "intensity_choic": [1, 33, 63], "intensity_rang": [1, 63, 72], "interact": [0, 63, 74, 75, 87, 88], "interest": [2, 16, 47, 73, 81, 83], "interfac": [0, 14, 16, 18, 41, 51, 54, 58, 74, 80, 83, 87], "intermedi": [45, 54, 83], "intern": [2, 26, 59, 63, 72, 76], "internet": [51, 62], "interpret": [6, 47, 63, 73, 74, 75, 76, 78, 96], "interrupt": [47, 54, 63, 66, 69, 72, 92], "intersect": 46, "intersection_union_ratio_cutoff": 53, "interv": [1, 15, 47, 53, 54, 59, 60, 63, 66, 69, 72, 82, 86], "interval_width_degre": [53, 59, 60], "intervent": 83, "intgrat": 30, "intris": 14, "introduc": [2, 75, 76], "introductori": 80, "inv": 14, "inv_d2": 10, "invalid": [15, 50, 74, 82, 85, 86], "invalidphilerror": [32, 33], "invers": [2, 3, 14, 40, 41, 51, 54, 58, 72, 78, 82, 84, 86], "inverse_greyscal": 45, "inverse_scale_factor": [3, 15], "inverse_scale_factor_vari": 3, "inverse_ub_matrix": 33, "invert": [51, 52, 78, 82, 86], "invert_rotation_axi": 52, "investig": [15, 74, 75, 77, 82, 83, 84, 86], "invis": 95, "invit": 0, "invok": 1, "involv": [15, 35, 76], "invvar": 63, "io": [4, 82, 84, 86, 90], "iob": 84, "iotbx": 18, "ioutil": 33, "ipanel": 14, "iqr": [47, 51, 53, 54, 59, 60], "iqr_multipli": [53, 59, 60], "iri": 0, "irradi": 54, "irrespect": 82, "is_consist": 24, "is_marked_for_reject": 26, "is_scal": [4, 15], "is_similar_to": [22, 23, 25], "is_single_file_read": 26, "is_stil": 16, "isbn": 0, "isfil": 83, "isi": 94, "isigi_cutoff": [38, 54], "isigma": [43, 63, 72], "isigma_cutoff": [1, 63], "isigma_rang": [1, 63, 72], "isn": 81, "isoform": 53, "isol": 77, "isomorph": [72, 76, 83], "isotrop": [11, 18, 40, 77, 84], "issu": [14, 54, 74, 76, 77, 78, 82, 83, 84, 86, 87, 90, 93], "item": [11, 16, 33, 53, 54, 59, 60, 74, 82, 85, 86], "iter": [1, 11, 14, 16, 23, 40, 41, 51, 53, 54, 58, 59, 60, 63, 64, 72, 78, 83], "iter_levelord": 23, "iter_panel": 23, "iter_preord": 23, "its": [2, 14, 33, 35, 40, 48, 53, 59, 60, 63, 70, 72, 74, 75, 77, 82, 86, 87, 92, 94], "itself": [75, 81], "iucr": 2, "iucrj": 95, "ivanova": 95, "iwata": 83, "j": [2, 11, 18, 35, 40, 47, 53, 64, 66, 72, 74, 76, 79, 84, 85, 95], "j0": [47, 53, 64, 66], "j1": [47, 53, 64, 66], "ja": 95, "jacobian": [14, 53, 59, 60], "jacobian_condition_numb": 14, "jame": [0, 83, 98], "jan": [73, 95], "jana2020": 44, "jbluic": 95, "jd": 74, "je": 95, "jen": 83, "jenkin": 0, "jessica": 73, "jf": [73, 95], "ji": 95, "jiang": 95, "jiffi": 88, "jiggeri": 6, "jim": [0, 97], "jl": 95, "jm": [75, 95], "job": [12, 16, 47, 53, 54, 59, 60, 63, 74, 81, 82, 83, 86, 87], "job_card": 30, "joblist": [12, 19], "johan": 0, "johnson": 95, "joinpath": 4, "joint": [1, 3, 53, 59, 60, 63, 80, 81], "joint_analysi": 63, "joint_export": 83, "joint_index": [53, 82, 86], "joint_json": 67, "joint_mtz": 83, "jon": 0, "journal": [0, 14, 19, 53, 59, 60], "jp": [75, 95], "jpeg": 45, "json": [3, 11, 18, 24, 30, 34, 36, 38, 40, 43, 44, 52, 54, 59, 62, 63, 67, 68, 69, 70, 75, 76, 82, 84, 86, 96], "jul": 95, "juli": 99, "jump": [78, 86], "jun": [75, 95], "june": 99, "junk": [82, 86], "just": [4, 11, 14, 23, 25, 53, 63, 73, 74, 78, 81, 82, 83, 85, 86, 87, 96, 97], "jw": 95, "k": [0, 2, 11, 18, 37, 40, 53, 61, 75, 78, 82, 84, 85, 86, 95], "k1": [53, 59, 60], "k2": [53, 59, 60], "k3": [53, 59, 60], "kabsch": [0, 97], "kai": 97, "kaiser": 95, "kappa": [25, 52], "kappadirect": 25, "kappagoniomet": [25, 27], "kappascanaxi": 25, "kapton": 54, "kapton_2019": 54, "kapton_half_width_mm": 54, "kapton_thickness_mm": 54, "katrin": 0, "kb": [1, 4, 15, 63, 72], "kbscalingmodel": 15, "ke": 95, "keabl": 95, "keen": 78, "keep": [1, 14, 38, 43, 44, 53, 59, 60, 66, 70, 72, 73, 76, 81, 87, 97], "kei": [4, 6, 14, 18, 48, 76, 82, 83, 86, 87], "kept": [6, 53, 59, 60, 75, 76, 81], "kern": 95, "kernel": [18, 40, 47, 51, 69, 72], "kernel_normalis": 18, "kernel_s": [42, 45, 47, 51], "kevin": 0, "keyword": 31, "kg": 35, "khr": 9, "kindli": [76, 78], "kingdom": 92, "kj": 74, "knew": 74, "know": [21, 23, 25, 54, 72, 73, 74, 77, 82, 83, 84, 86, 87], "knowledg": [0, 2, 35], "known": [11, 25, 47, 53, 64, 74, 77, 78, 81, 82, 86, 87, 96], "known_axi": 25, "known_crystal_model": 11, "known_orient": [11, 83], "known_symmetri": 53, "ko": 95, "kobe": 74, "kobilka": 95, "koglin": 95, "konstantino": 83, "koroidov": 95, "kovaleva": 95, "kroon": 97, "kruse": 95, "kunstlev": [0, 2, 11, 95], "kw": 73, "kwarg": [11, 14, 16, 24, 31, 33], "kwd": 14, "l": [2, 14, 18, 37, 53, 61, 74, 75, 76, 77, 78, 82, 84, 85, 86, 88, 93, 95], "l1": 75, "l2": 75, "l_0": 35, "l_1": 35, "l_i": 35, "l_min": [11, 53], "lab": [2, 45, 51], "label": [2, 14, 43, 45, 47, 59, 68, 70, 72, 84, 85], "label_indic": 68, "labelit": [48, 78], "laboratori": [0, 11, 21, 35, 68, 74, 75, 83, 90, 92, 98], "lack": [82, 86, 87], "lactamas": [86, 87], "lai": 95, "laksmono": 95, "lambda": 35, "lamp": 95, "larg": [14, 44, 51, 53, 59, 60, 63, 70, 72, 74, 75, 76, 81, 82, 84, 86, 87, 88, 89, 96, 97], "larger": [11, 53, 54, 56, 59, 60, 78, 84], "largest": [11, 14, 38, 40, 84], "laser": [95, 97], "lassal": 95, "last": [12, 14, 53, 59, 60, 74, 83, 84], "latch": 78, "late": 77, "later": [59, 70, 73, 87, 88], "latest": [7, 14, 79], "latim": 95, "latt": 73, "latter": [74, 82, 86], "lattic": [2, 3, 11, 18, 40, 44, 53, 72, 75, 76, 78, 80, 84, 95, 96, 98], "lattice_group": [18, 40, 69, 72], "lattice_id": 18, "lattice_search": 19, "lattice_search_strategi": 4, "lattice_symmetri": 18, "lattice_symmetry_max_delta": [18, 40, 69, 72], "latticesearch": 11, "laue": [11, 14, 18, 24, 40, 53, 59, 60, 69, 72, 73, 76, 82, 84, 85, 86, 94], "laue_group": [18, 69, 72, 84], "laue_manag": 14, "lauegroupanalysi": [18, 19], "laueleastsquaresresidualwithrmsdcutoff": [14, 19], "lauemixedweightingstrategi": [14, 19], "lauereflectionmanag": [14, 19], "lauestatisticalweightingstrategi": [14, 19], "launch": [74, 87], "law": [82, 86], "lawrenc": [0, 90, 92], "layout": 87, "lazi": 26, "lbfg": [11, 14, 18, 63, 82, 84, 86], "lbfgs_core_param": 11, "lbfgs_termination_param": 11, "lbfgs_with_curv": [18, 19], "lbfgscurv": [14, 19, 53, 59, 60], "lbl": [9, 48], "lbnl": [0, 90], "lcl": 81, "lcv": 83, "lcy": 88, "le": [11, 18, 53, 78], "lead": [1, 53, 59, 60, 77, 78, 82, 83, 86, 87], "learn": [73, 74, 81], "learnt": 97, "least": [1, 14, 53, 59, 60, 63, 74, 82, 84, 86, 87], "leastsquarespositionalresidualwithrmsdcutoff": [14, 19], "leastsquarespositionalresidualwithrmsdcutoffspars": [14, 19], "leastsquaresstillsresidualwithrmsdcutoff": [14, 19], "leastsquaresstillsresidualwithrmsdcutoffspars": [14, 19], "leav": [74, 87], "lebedev": 77, "led": 0, "lee": 0, "left": [2, 35, 78, 87], "leginon": 73, "leginon_offset": 73, "leinweb": 0, "lemk": 95, "len": [4, 6, 75, 83], "length": [11, 14, 18, 33, 35, 53, 72, 73, 77, 81, 86], "lepag": [40, 84], "lepage_max_delta": 60, "lesli": [0, 54, 97, 98], "less": [7, 18, 40, 47, 50, 51, 53, 54, 60, 63, 69, 72, 73, 74, 77, 78, 81, 82, 83, 86, 87, 88], "lesson": 73, "let": [4, 73, 74, 76, 78, 81, 82, 83, 84, 86, 87], "level": [0, 1, 4, 12, 18, 38, 43, 45, 47, 53, 59, 60, 63, 72, 74, 81, 83, 87, 88, 96], "levenberg": [14, 82, 84, 86], "levenbergmarquardtiter": [14, 19], "levi": 2, "levmar": [53, 59, 60, 63], "li": [0, 2, 53, 59, 60], "liabil": 92, "liabl": 92, "liang": 74, "lib": 79, "libgl": 9, "librari": [8, 30, 73, 83], "libtbx": [4, 6, 11, 15, 18, 83], "libtbx_refresh": 4, "lie": [2, 77], "life": 78, "light": [0, 35, 80, 81, 82, 83, 84, 85, 86, 87, 92, 99], "like": [1, 2, 3, 4, 7, 11, 14, 26, 54, 73, 74, 76, 78, 79, 81, 82, 83, 84, 86, 87, 88], "likelihood": [18, 40, 41, 51, 54, 58, 69, 73, 76, 82, 84, 85, 86, 87], "likelihood_cutoff": [11, 53], "limit": [11, 14, 37, 40, 41, 43, 46, 47, 49, 50, 51, 53, 54, 55, 58, 63, 65, 67, 72, 73, 74, 75, 76, 79, 81, 82, 83, 84, 85, 86, 87, 88, 92, 95, 97], "limit_image_rang": 15, "limit_resolution_bi": 53, "lin": 95, "line": [1, 7, 9, 12, 33, 52, 63, 71, 73, 74, 77, 79, 80, 81, 82, 83, 86, 87, 88, 96], "linear": [11, 14, 35, 53, 54, 63, 82, 83, 86, 87], "linear2d": 54, "linear3d": 54, "linearis": 14, "linearli": [14, 63], "link": [14, 65, 88], "linkag": 53, "linux": [7, 24, 74, 79, 81, 83], "list": [4, 7, 11, 12, 14, 15, 16, 18, 24, 25, 26, 29, 30, 31, 33, 35, 38, 44, 47, 50, 52, 53, 54, 56, 59, 60, 63, 73, 74, 75, 76, 77, 78, 79, 82, 83, 84, 86, 90, 92, 93, 94, 96], "liter": 47, "littl": [23, 25, 73, 74, 75, 76, 81, 82, 86, 88], "lj": 95, "ll": [74, 81, 83, 84, 86, 87], "ll_toler": [41, 51, 54, 58], "lm": [63, 95], "lmax": [1, 63, 72], "load": [6, 16, 24, 26, 30, 32, 33, 48, 51, 63, 76, 79, 82, 83, 84, 86, 87], "load_error_model": 15, "load_imag": 16, "load_model": [24, 33, 51], "loc": 18, "loc_in_list": 33, "local": [4, 7, 45, 47, 53, 62, 74, 87, 91], "localhost": 48, "locat": [3, 18, 33, 50, 53, 59, 60, 83, 84, 86, 87], "loe": 97, "log": [1, 11, 14, 18, 33, 35, 37, 38, 40, 41, 43, 44, 47, 50, 51, 52, 53, 54, 58, 59, 60, 61, 63, 64, 69, 70, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 87, 96], "log_summari": [32, 33], "logarithm": 53, "logfil": 83, "logger": 83, "logic": 47, "login": 9, "loglinear2d": 54, "loglinear3d": 54, "lond": 95, "long": [10, 12, 14, 24, 25, 26, 63, 74, 77, 82, 86, 87, 88], "longer": [75, 81, 82, 83, 84, 85, 86], "longest": 4, "look": [3, 4, 47, 52, 53, 59, 60, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 97], "lookup": [47, 52, 53, 54, 75], "lookup_symbol": 53, "loop": [14, 76, 83], "lorentz": [82, 86, 87], "loss": [72, 92], "lot": [73, 76, 81, 85, 87], "love": 79, "lovelac": 94, "low": [1, 11, 37, 47, 50, 51, 53, 63, 72, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88], "low_memory_mean": [53, 59, 60], "low_res_spot_match": [4, 53], "lower": [11, 18, 53, 54, 59, 60, 63, 73, 81, 82, 84, 86, 87], "lower_bound": 18, "lowest": [43, 63, 74, 78, 82, 86, 87], "lowresspotmatch": 11, "lp": [3, 82, 86, 87], "lsf": [47, 54], "lstbx": 14, "lucier": 73, "luck": 73, "lui": [0, 98], "lukacik": 95, "lure": 11, "lvalu": [10, 12, 22, 23, 24, 25, 26], "lys_ed_dataset_": 75, "lys_ed_dataset_1": 75, "lys_ed_dataset_2": 75, "lys_ed_dataset_3": 75, "lys_ed_dataset_4": 75, "lys_ed_dataset_5": 75, "lys_ed_dataset_6": 75, "lys_ed_dataset_7": 75, "lysozym": 76, "lyubimov": 95, "m": [2, 11, 35, 40, 46, 73, 74, 76, 79, 82, 84, 85, 86, 87, 95, 96], "m1000": 73, "ma": [95, 99], "mac": 7, "machin": [48, 49, 96, 97], "machineri": 95, "macosx": 91, "macro": [53, 59, 64, 78, 81, 82, 86, 87], "macrocycl": [53, 59, 60, 74, 78, 81, 82, 86, 87], "macrocyl": [78, 82, 86, 87], "macromolecul": [82, 84, 86], "macromolecular": [0, 1, 70, 94, 95], "made": [1, 2, 15, 23, 33, 35, 38, 40, 53, 59, 60, 74, 82, 83, 84, 86, 87, 88], "madmergedmtzwrit": [32, 33], "magic": 4, "magic_paramet": 4, "magnif": 73, "magnitud": [2, 35, 62, 63, 78], "mahalanobi": [53, 59, 60], "mai": [0, 1, 2, 3, 4, 7, 9, 11, 12, 14, 15, 18, 34, 35, 40, 41, 42, 46, 47, 48, 49, 51, 52, 53, 54, 59, 60, 62, 63, 66, 70, 72, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 91, 92, 95, 96, 99], "main": [0, 3, 9, 14, 23, 34, 63, 71, 79, 80, 86, 96], "mainli": [53, 54, 77], "maintain": [14, 48], "major": [7, 54, 74, 78, 83, 84, 87], "make": [0, 2, 4, 9, 15, 23, 25, 45, 53, 54, 55, 59, 60, 63, 70, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 90, 93], "make_app": 33, "make_beam": 21, "make_combined_plot": 15, "make_detector": 23, "make_goniomet": 25, "make_imageset": 26, "make_kappa_goniomet": 25, "make_multi_axis_goniomet": 25, "make_polarized_beam": 21, "make_polychromatic_beam": 21, "make_scan": 29, "make_scan_from_properti": 29, "make_sequ": 26, "mald": 74, "manag": [1, 12, 14, 53, 59, 60, 63, 82, 86, 98], "mandatori": 14, "manglik": 95, "mani": [0, 2, 4, 16, 38, 40, 48, 73, 74, 76, 77, 78, 79, 82, 83, 84, 86, 87], "manifest": 78, "manner": [76, 82, 86, 87, 96], "manual": [52, 73, 74, 83, 88], "map": [11, 18, 40, 42, 45, 47, 50, 51, 62, 65, 76, 77, 78, 82, 84, 86, 87], "mar": [11, 95], "marcin": 0, "margin": [17, 41, 51, 54, 77], "mark": [47, 74, 82, 86, 87], "mark_for_reject": 26, "marker": [82, 86], "marker_s": 68, "marku": 0, "marquadt": 14, "marquardt": [14, 82, 84, 86], "mashor": 73, "mask": [3, 16, 23, 26, 31, 36, 46, 47, 50, 51, 52, 54, 66, 75, 82, 86], "mask_gener": 16, "mask_param": 51, "masker": 26, "mass": [35, 41, 51, 54, 58, 82, 86], "master": [48, 73, 75, 76], "master_path": 26, "mat": 44, "mat3": [22, 25], "mat3_doubl": 25, "match": [11, 14, 18, 29, 33, 38, 48, 53, 59, 60, 66, 74, 81, 82, 83, 86, 87, 88], "match_wavelength": [32, 33], "materi": [0, 23, 35, 52, 82, 86, 92], "math": 11, "mathbf": [2, 35], "mathew": 95, "mathsf": 2, "matplotlib": [59, 70], "matric": [2, 39, 84, 85], "matrix": [1, 6, 14, 18, 22, 39, 40, 44, 52, 53, 57, 59, 60, 62, 63, 70, 72, 74, 81, 82, 83, 85, 86, 88], "matter": [51, 88], "matthew": 0, "matur": 81, "max": [40, 41, 46, 51, 52, 53, 54, 58, 63, 64, 72, 73, 74, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 96], "max_angular_differ": 18, "max_batch_s": 38, "max_cal": [18, 40, 72], "max_cel": [19, 53, 64, 82, 86, 87], "max_cell_estim": 53, "max_cell_multipli": 11, "max_cell_volume_change_fract": [41, 51, 54, 58], "max_clust": [38, 72], "max_combin": [11, 53], "max_cycl": [63, 72], "max_delta": [11, 18, 53], "max_fre": 72, "max_height_fract": [11, 53], "max_imag": 42, "max_it": [41, 51, 54, 58], "max_iter": [14, 18, 40, 53, 59, 60, 63, 72], "max_lattic": [11, 53, 85, 96], "max_length": 33, "max_memory_usag": 54, "max_n_group": [53, 59, 60], "max_pair": 53, "max_percent_remov": [63, 72], "max_possible_wl": 33, "max_quad": 53, "max_refin": 53, "max_refl": 53, "max_reflect": [64, 65], "max_reflections_per_experi": 38, "max_sample_s": 14, "max_separ": [41, 47, 51, 54, 58, 73], "max_shift_over_esd": 14, "max_spot": 73, "max_spot_s": [16, 47, 75], "max_strong_pixel_fract": [16, 47], "max_triplet": 53, "max_vector": 53, "maxd": 16, "maxim": [53, 59, 60], "maximis": 44, "maximum": [11, 15, 16, 17, 18, 38, 40, 41, 43, 44, 46, 47, 51, 52, 53, 54, 59, 60, 63, 64, 72, 76, 82, 84, 86, 87, 88], "maximum_sample_s": [53, 54, 59, 60], "maximum_trusted_valu": 47, "mayb": 76, "mayer": 73, "mc": [74, 77, 78, 79, 82, 85, 86, 95], "mcaulei": 95, "mcd": [53, 59, 60, 82, 83, 86, 87], "mcdonagh": 95, "mcfarlan": 95, "mcgilvrai": 73, "mcphillip": 95, "mcqueen": 95, "md": 35, "me": 95, "mea": [84, 85], "mean": [2, 10, 15, 36, 42, 45, 47, 51, 53, 59, 60, 63, 72, 74, 76, 77, 81, 82, 84, 85, 86, 87], "meaning": 2, "meant": 75, "measur": [1, 2, 3, 11, 14, 60, 63, 72, 74, 76, 82, 83, 84, 85, 86, 87, 95], "mechan": [81, 83], "med": [81, 82, 83, 86, 95], "med_a": [40, 84, 96], "med_alpha": [40, 84, 96], "med_b": [40, 84, 96], "med_beta": [40, 84, 96], "med_c": [40, 84, 96], "med_gamma": [40, 84, 96], "median": [18, 40, 44, 53, 59, 60, 63, 72, 84], "median_unit_cel": [18, 19], "medic": [0, 90], "medium": [1, 63, 72, 88], "meet": [0, 90, 97, 98], "member": 26, "membran": 83, "memori": [1, 11, 14, 26, 38, 53, 54, 63, 81, 82, 86], "memread": [26, 27], "mendez": 0, "mental": 73, "mention": [84, 88], "mercado": 73, "merchant": 92, "mere": 93, "merg": [1, 33, 43, 44, 53, 55, 59, 60, 63, 72, 73, 74, 76, 83, 84, 87, 88], "merge_cbf": 71, "merge_n_imag": 55, "merge_panel_scope_extracts_by_id": [23, 27], "merged_arrai": 33, "merged_mtz": [1, 63], "mergedhalfdataset": 33, "mergedmtzwrit": [32, 33], "mess": [24, 54], "messag": [7, 33], "messagepack": 3, "messerschmidt": 95, "messi": 78, "messier": 78, "messing": 95, "met": 92, "metadata": [24, 33, 44, 52, 63, 73, 74, 75, 82, 86, 87, 96], "metal": 88, "metalloenzym": 95, "method": [0, 1, 2, 7, 11, 14, 15, 16, 18, 25, 26, 29, 40, 41, 43, 47, 49, 51, 53, 54, 58, 59, 60, 63, 64, 66, 69, 72, 73, 74, 78, 82, 83, 84, 86, 87, 95, 96], "methodologi": 97, "metr": 35, "metric": [40, 43, 53, 60, 72, 73, 74, 77, 78, 82, 83, 84, 85, 86, 87], "metric_subgroup": 18, "metric_supergroup": 11, "metrologi": [51, 80], "meyer": 2, "mh": 74, "mi": [74, 78, 81, 95], "miahnahri": 95, "michel": [0, 95], "micro": [74, 80], "microcryst": [73, 74, 95], "microfocu": 97, "micron": 90, "microscop": [73, 75], "microsecond": 95, "mid": 81, "middl": 73, "midpoint": 63, "might": [2, 4, 14, 35, 74, 77, 78, 81, 82, 83, 84, 86, 87], "milathianaki": 95, "miller": [2, 3, 18, 33, 39, 51, 53, 56, 68, 76, 77, 84, 85, 87], "miller_index": 3, "miller_indic": 11, "millimet": [82, 86], "millimetr": [3, 74], "million": 1, "mimick": 77, "min": [41, 46, 51, 52, 54, 58, 73, 74, 77, 78, 81, 82, 83, 84, 85, 86], "min_cc_half": [18, 40, 69, 72], "min_cel": [11, 53], "min_cell_volum": 53, "min_chunks": [16, 47], "min_cluster_s": 53, "min_complet": [63, 72, 76], "min_component_s": 56, "min_group": 63, "min_group_s": [53, 59, 60], "min_i_mean_over_sigma_mean": [18, 40, 69, 72], "min_ih": [63, 74], "min_isigi": [33, 44, 63, 82, 84, 86], "min_isigma": 63, "min_lattic": 53, "min_loc": [45, 47, 51], "min_multipl": [63, 72], "min_n_reflect": [41, 51, 54, 58], "min_nref_per_paramet": [53, 59, 60], "min_pair": [18, 40, 72], "min_parti": [63, 72, 82, 84, 86], "min_partition_s": 54, "min_per_area": 1, "min_per_dataset": 1, "min_pixel": 54, "min_reflect": [40, 63], "min_reflections_per_experi": 38, "min_sampl": 53, "min_sample_s": 14, "min_spot": [41, 51, 54, 58, 96], "min_spot_s": [16, 47, 49, 73, 75, 81, 82, 85, 86], "min_wl": 33, "min_zeta": [41, 51, 54, 58], "mind": 73, "mini": 4, "minicbf": 75, "minim": [14, 18, 40, 44, 72, 76, 82, 84, 86, 95, 96], "minimis": [14, 18, 39, 53, 59, 60, 63, 72, 82, 84, 86, 87, 89], "minimize_scipi": [18, 19], "minimize_scitbx_lbfg": [18, 19], "minimum": [11, 14, 17, 18, 40, 41, 43, 44, 46, 47, 51, 53, 54, 58, 59, 60, 63, 72, 76, 82, 84, 85, 86], "minimum_angular_separ": [11, 53], "minimum_number_of_reflect": [53, 59, 60], "minimum_sample_s": [53, 54, 59, 60], "miniut": 97, "minor": [7, 77], "minut": [81, 83, 84, 97], "mirror": [48, 74, 82, 84, 86, 90], "misigma": [43, 72], "misindex": [37, 53, 78], "mislead": 84, "misorient": 81, "miss": [56, 73, 74, 81, 84, 89], "misset": [2, 82, 86, 87], "missing_reflect": 71, "mitig": 11, "mitzner": 95, "mixin": 14, "mj": 95, "mkdir": [48, 73, 74, 75, 76, 81, 83, 84], "ml": [40, 73, 82, 84, 86], "ml_aniso": [18, 40, 69, 72], "ml_aniso_normalis": 18, "ml_iso": [18, 40, 69, 72], "ml_iso_normalis": 18, "mm": [3, 14, 23, 35, 47, 50, 51, 52, 53, 59, 60, 74, 78, 81, 82, 83, 85, 86, 87, 95], "mm_search_scop": [53, 64], "mmcif": [44, 70, 76], "mmm": 76, "mmtbx": 33, "mn\u2084ca": 95, "mod_python": 48, "mode": [4, 15, 18, 33, 34, 40, 52, 53, 59, 60, 61, 63, 72, 74, 75, 76, 82, 83, 86, 87], "model": [0, 3, 6, 10, 11, 12, 14, 18, 19, 26, 27, 30, 31, 32, 33, 34, 35, 36, 38, 39, 40, 41, 42, 44, 45, 47, 50, 51, 52, 53, 54, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 68, 69, 70, 72, 73, 74, 76, 77, 81, 82, 83, 84, 85, 86, 87, 88, 89, 93, 95, 96, 97], "model_evalu": 19, "model_likelihood": 11, "model_param": 15, "modelevalu": 11, "modelnam": 4, "modelrank": 11, "modelrankfilt": 11, "modelrankweight": 11, "models_1": 39, "models_2": 39, "models_with_profil": 41, "modern": 2, "modif": [55, 92], "modifi": [15, 40, 41, 47, 48, 50, 53, 64, 66, 73, 81, 82, 83, 84, 85, 86], "modpython": 48, "modul": [2, 14, 15, 18, 33, 63, 77, 79, 83, 84, 86, 87], "modular": 81, "modulation_correct": [1, 63], "modulenotfounderror": 4, "mol": 73, "molecul": 80, "molecular": [73, 74, 75, 77, 95, 98], "moment": [53, 59, 60, 81], "mono": [11, 53], "monochromat": [52, 94], "monoclin": [18, 40, 60, 69, 72, 74, 82, 86, 87], "montero": [0, 95, 98], "month": 95, "moor": 14, "moral": 78, "more": [1, 3, 4, 7, 9, 11, 18, 33, 36, 38, 46, 47, 48, 53, 54, 59, 60, 63, 66, 69, 71, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 93, 96, 97], "mori": 95, "moriarti": [0, 2], "morri": 84, "mosaic": [3, 22, 41, 51, 53, 54, 58, 74, 79, 82, 86, 96], "mosaiccrystalkabsch2010": [22, 27], "mosaiccrystalsauter2014": [22, 27], "mosaicity_max_limit": [41, 51, 54, 58], "mosaicity_toler": 22, "mosflm": [0, 2, 22, 44, 52, 54, 97], "mosflm_a_matrix": 22, "mosflm_beam_centr": 52, "most": [1, 2, 4, 7, 11, 15, 18, 33, 35, 38, 53, 54, 71, 73, 74, 76, 79, 82, 83, 84, 86, 87, 88, 96, 97], "mostli": [82, 86, 87], "motion": 95, "motiv": [63, 82, 83, 86], "motor": 2, "motorlogi": 48, "mount": [2, 35], "mous": [73, 74, 87], "move": [23, 33, 53, 59, 60, 73, 77, 81, 83, 84, 86, 87], "movement": 0, "movi": 73, "mp": [47, 53, 54, 59, 60, 73, 77, 78, 79, 82, 85, 86], "mp_chunksiz": 16, "mp_method": 16, "mp_njob": 16, "mp_nproc": 16, "mplex": 76, "mpm": 48, "mpm_prefork_modul": 48, "mpro": 80, "mpro_x0692": 82, "mr": 95, "mrc": 98, "mt": 74, "mtb": [74, 75, 95], "mtz": [1, 33, 40, 43, 44, 61, 63, 72, 73, 74, 75, 76, 79, 81, 83, 84, 85, 88, 93], "mtz_unmerg": 79, "mtzwriterbas": [32, 33], "mu": [14, 23, 35, 82, 86], "much": [0, 9, 73, 74, 78, 81, 82, 83, 84, 86, 87, 88], "mult": [73, 82, 84, 85, 86], "multi": [1, 2, 15, 16, 18, 33, 38, 40, 42, 44, 45, 48, 51, 52, 53, 54, 59, 60, 63, 72, 80, 82, 86, 87, 95], "multi_axi": 25, "multi_axis_goniometer_from_phil": 25, "multi_cryst": 84, "multi_crystal_analysi": 72, "multi_dataset": [1, 63], "multi_panel": [45, 51, 52], "multiaxisgoniomet": [25, 27], "multipl": [1, 3, 4, 11, 16, 33, 34, 36, 38, 39, 43, 45, 47, 50, 51, 52, 53, 54, 59, 60, 63, 64, 66, 68, 69, 70, 72, 73, 74, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96, 97, 98], "multiple_lattice_search": 53, "multiplex": [71, 80, 95], "multipli": [35, 41, 47, 51, 53, 54, 58, 59, 60], "multiplicities_h_0": 76, "multiplicities_k_0": 76, "multiplicities_l_0": 76, "multiprocess": [14, 24, 53, 54, 59, 60, 82, 86], "multiscal": 84, "multivari": [41, 51, 54, 58, 87], "muon": 94, "murshudov": [0, 95, 98], "must": [1, 2, 4, 7, 14, 15, 33, 36, 52, 53, 54, 59, 60, 63, 64, 66, 74, 75, 76, 82, 84, 86, 87, 92], "mutual": [2, 51], "muuss": 74, "mv": 81, "mx": [79, 82, 84, 86, 88, 97], "mx27124": 82, "my": 4, "my_format_modul": 4, "mybeamlin": 4, "mycalingmodel": 4, "myd88": [74, 80], "myeloid": 74, "myformat": 4, "mylatticesearch": 4, "mymodel_phil_str": 4, "myparam": 7, "mypath": 4, "myproject": 4, "myscalingmodel": 4, "mystrategi": 4, "mystrategy_phil_str": 4, "n": [0, 2, 3, 4, 6, 11, 18, 21, 22, 33, 35, 40, 54, 58, 72, 73, 82, 84, 85, 86, 87, 95], "n_absorption_bin": [1, 63], "n_acentr": 84, "n_bin": [15, 38, 47, 51, 54, 63, 72], "n_cycl": [41, 51, 54, 58], "n_digit": 44, "n_equat": 14, "n_group": 84, "n_index": 11, "n_indexed_cutoff": [11, 53], "n_indexed_weight": [11, 53], "n_iqr": [47, 51], "n_macro_cycl": [41, 51, 53, 54, 58, 64, 78], "n_merg": 44, "n_modulation_bin": [1, 63], "n_new_param": 15, "n_old_param": 15, "n_param": 15, "n_paramet": [14, 82, 84, 86], "n_point": [11, 53], "n_ref": 18, "n_refl": [38, 82, 84, 86], "n_refl_panel_list": 38, "n_resolution_bin": [1, 63], "n_shell": 72, "n_sigma": [41, 51, 54, 58], "n_spot": 53, "n_static_macrocycl": 59, "n_subset": 38, "n_subset_method": 38, "n_subset_split": 54, "n_trial": [53, 59, 60], "n_xtal": [40, 84, 96], "na": 74, "nakan": 0, "name": [2, 3, 4, 6, 7, 14, 15, 23, 24, 25, 26, 30, 31, 33, 35, 36, 42, 44, 45, 48, 50, 51, 52, 53, 59, 60, 62, 63, 66, 70, 78, 79, 81, 82, 84, 85, 86, 87, 88, 92], "nannenga": 95, "nano": 97, "nanoimag": 73, "nanson": 74, "narrow": [11, 47, 51, 53, 83, 87], "nass": 95, "nat": [74, 95], "nathaniel": 0, "nation": [0, 35, 90, 92], "nativ": [18, 79, 81, 84, 85], "nativig": 86, "natl": [2, 95], "natur": [53, 59, 60, 84, 86, 87, 95], "nave": 53, "navig": [82, 84, 87], "nbin": [16, 43, 63, 72], "nc": [77, 84], "ndarrai": 18, "nearest": [53, 54, 56, 66, 87], "nearest_neighbor": 11, "nearest_neighbor_percentil": [11, 53], "nearest_neighbour": [11, 53], "nearli": [11, 14, 78, 81], "neat": [78, 81], "necessari": [1, 2, 11, 15, 40, 54, 73, 75, 76, 81, 82, 86, 88, 93], "necessit": 26, "need": [1, 2, 4, 9, 14, 16, 21, 24, 25, 40, 41, 47, 51, 54, 58, 60, 63, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 91, 97], "needl": 63, "neg": [73, 75, 76, 79, 84], "neglig": [74, 82, 86, 92], "negro": 73, "neighbor": 54, "neighboranalysi": 11, "neighbour": [53, 56, 82, 86, 87], "neither": 92, "nelson": 95, "ness": 53, "nest": [4, 15, 46], "net": [18, 48, 79, 82, 87, 90], "netzcc": [40, 73, 76, 82, 84, 85, 86, 87], "neuron": 95, "neutron": [2, 52], "never": 81, "nevertheless": [2, 77, 81], "new": [0, 1, 2, 7, 9, 14, 15, 16, 23, 26, 48, 53, 59, 60, 63, 71, 73, 74, 75, 77, 78, 81, 82, 83, 84, 86, 87, 90, 91, 94, 95, 97], "new_image_0": 15, "new_image_rang": 15, "new_norm_fac": 15, "newdir": 83, "newli": [82, 86], "newton": 14, "next": [6, 40, 74, 76, 82, 84, 85, 86, 87], "nexu": [33, 42, 44], "nfold": 63, "nframe": 54, "nframes_hist": [12, 19], "ng": 95, "ni": 73, "nice": [33, 73, 74], "nicer": 81, "nichola": 0, "nick": 97, "nien": 83, "nieusma": 73, "nigel": 0, "niggli": [40, 84], "nightli": [79, 91], "nist": 35, "nj": 73, "njob": [47, 54], "nk": 95, "nn": 53, "nn_hist": 11, "nn_per_bin": [11, 53], "no_shoeboxes_2d": 16, "noauto": 72, "node": [23, 87], "nois": [42, 47, 51, 75, 82, 84, 86], "non": [11, 14, 53, 59, 60, 72, 84], "non_linear_l": 14, "non_linear_ls_mixin": 14, "none": [1, 4, 6, 10, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 29, 30, 31, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 56, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72, 74, 78, 83, 84, 96], "nonisomorph": 1, "nonumb": 2, "nor": 92, "norm": 14, "norm_fac": 15, "normal": [14, 21, 35, 38, 41, 51, 52, 53, 54, 58, 59, 60, 78, 79, 82, 86, 87], "normal_matrix": 14, "normalis": [1, 15, 18, 35, 37, 40, 43, 63, 69, 72, 82, 84, 86], "normalise_bin": 37, "normdevoutlierreject": 15, "notabl": 81, "note": [14, 35, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 91, 96], "noth": [25, 52, 74], "notic": [77, 81, 82, 86, 87, 92], "notwithstand": [2, 78, 81], "novemb": 99, "now": [4, 6, 33, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 93], "np": 18, "nproc": [1, 14, 16, 18, 40, 47, 49, 53, 54, 59, 60, 63, 64, 72, 73, 82, 83, 86], "nref": [73, 74, 78, 81, 82, 83, 84, 85, 86, 87], "nref_per_degre": 14, "nsigma": 54, "nsigma_": [45, 51], "nsigma_b": [45, 51], "ntry": 73, "null": [31, 53, 54, 59, 60, 81, 83], "null_background_ext": 31, "nullbackgroundext": [31, 32], "nullify_all_single_file_reader_format_inst": 24, "num": [82, 83, 85, 86], "num_reflect": 12, "num_scan_point": 25, "number": [1, 2, 4, 7, 11, 12, 14, 15, 16, 17, 18, 33, 37, 38, 40, 41, 43, 44, 45, 47, 48, 49, 51, 52, 53, 54, 55, 58, 59, 60, 63, 64, 65, 66, 67, 69, 70, 72, 73, 74, 76, 78, 81, 82, 83, 84, 85, 86, 87, 88, 90, 95, 96], "number_of_partit": 54, "numer": [0, 1, 14, 18], "nx": [44, 47], "nxmx": 44, "ny": 47, "o": [0, 2, 4, 22, 73, 75, 79, 83, 91, 95], "oa": 95, "ob": [73, 82, 84, 85, 86, 95], "obj": [4, 15, 24, 28], "object": [2, 10, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 30, 31, 33, 52, 53, 59, 60, 66, 81, 83, 97, 98], "objective_onli": 14, "obliqu": [18, 40, 60, 69, 72], "observ": [11, 14, 16, 18, 35, 40, 41, 44, 53, 59, 60, 62, 65, 66, 69, 74, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88], "obtain": [1, 2, 4, 9, 14, 15, 40, 53, 59, 60, 75, 77, 78, 82, 84, 95], "obviou": [75, 82, 83, 86], "obvious": 6, "oc": [77, 78, 79, 85, 86], "occas": [41, 76], "occur": [74, 75, 82, 86, 87], "oct": 95, "octob": 99, "odd": 77, "off": [1, 18, 53, 54, 59, 60, 63, 73, 74, 78, 82, 83, 86, 87], "offer": [78, 97], "offset": [11, 15, 23, 52, 53, 63, 64, 74, 78, 81, 82, 86], "offsetparallaxcorrectedpxmmstrategi": 52, "often": [1, 2, 4, 11, 35, 53, 74], "ogata": 95, "ok": [79, 87, 88], "okai": [73, 74, 83], "old": 78, "old_test_flag_valu": 72, "older": [42, 87], "oliv": 0, "omega": [2, 25, 52], "omit": [82, 86], "onc": [7, 40, 47, 52, 53, 73, 74, 76, 81, 82, 85, 86, 87, 88], "one": [1, 2, 6, 11, 14, 15, 16, 24, 36, 38, 40, 44, 47, 53, 54, 59, 60, 61, 63, 69, 70, 72, 73, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96], "one_osc_width": 15, "ones": 73, "ongo": [83, 97], "onli": [1, 2, 6, 7, 11, 14, 18, 26, 33, 36, 38, 44, 45, 46, 47, 53, 54, 55, 56, 59, 60, 63, 69, 70, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93, 96], "onlin": [35, 74, 75], "only_save_target": 63, "only_target": [1, 63], "ons": 33, "onto": [11, 53, 77, 78], "onward": 77, "ooooooooooooooooooooooooooooooooooooooooooooooooooooooooooo": 79, "oooooooooooooooooooooooooooooooooooooooooooooooooooooooooooo": 79, "op": [18, 73, 77, 78, 79, 82, 85, 86, 88], "open": [0, 3, 51, 71, 73, 74, 76, 82, 84, 86, 87, 91], "oper": [2, 4, 14, 18, 24, 37, 39, 40, 46, 47, 48, 60, 61, 73, 74, 76, 77, 78, 81, 82, 84, 85, 86, 87, 88], "oppos": 63, "opposite_of_grad_object": 14, "optic": 97, "optim": [1, 18, 74, 82, 84, 86, 87, 95], "optimis": [11, 63, 64, 72, 73, 74, 78, 82, 84, 86, 87], "optimise_basis_vector": 11, "optimise_initial_basis_vector": 53, "option": [3, 4, 6, 7, 11, 15, 18, 33, 34, 38, 39, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 57, 59, 60, 61, 62, 63, 66, 67, 68, 69, 70, 72, 74, 76, 77, 81, 82, 83, 84, 85, 86, 87, 88, 89, 93, 96], "optionpars": [32, 33], "orang": 73, "order": [1, 4, 9, 11, 14, 15, 23, 33, 36, 38, 52, 53, 54, 55, 59, 60, 63, 74, 78, 81, 82, 83, 84, 86, 87, 88], "org": [11, 18, 47, 48, 53, 59, 60, 75, 82, 88], "organ": [73, 88], "organis": [76, 99], "orient": [11, 35, 39, 41, 51, 53, 54, 57, 58, 59, 60, 62, 72, 73, 75, 81, 82, 86, 87, 88, 95, 96, 97], "orientation_decomposit": [57, 62], "origin": [2, 3, 4, 23, 38, 46, 52, 53, 64, 66, 72, 74, 75, 76, 78, 79, 82, 83, 86, 87, 94], "origin_toler": [23, 24], "orthogon": [2, 35, 53, 59, 60], "orthonorm": 2, "orthorhomb": [73, 75, 77, 78], "osc_rang": 15, "osc_start": 29, "osc_width": 29, "oscil": [1, 3, 12, 15, 29, 38, 52, 53, 59, 60, 63, 75, 77, 82, 86], "other": [2, 4, 7, 14, 22, 23, 25, 38, 40, 42, 47, 53, 54, 59, 60, 63, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 90, 92, 93, 96, 97], "other_crystal_model": 11, "otherwis": [14, 21, 46, 47, 50, 51, 53, 59, 60, 64, 74, 75, 81, 82, 86, 87, 92], "our": [0, 2, 4, 74, 81, 82, 83, 86, 87, 88, 93, 98], "out": [4, 7, 9, 14, 22, 33, 38, 44, 46, 47, 50, 51, 53, 59, 60, 73, 74, 75, 78, 81, 82, 83, 84, 86, 87, 92], "out_beam_plan": [53, 59, 60], "out_spindle_plan": [53, 59, 60, 73, 75], "outer": [43, 48, 72, 81, 88], "outgo": 1, "outlier": [1, 14, 15, 40, 53, 54, 59, 60, 63, 72, 73, 76, 81, 82, 83, 84, 85, 86, 87], "outlier_detector": 14, "outlier_in_sc": 15, "outlier_index_arrai": 15, "outlier_prob": [41, 51, 54, 58], "outlier_reject": [19, 63, 72], "outlier_zmax": [63, 87], "outlierrejectionbas": 15, "outlin": [75, 78, 82, 86], "outofsequencefil": 75, "output": [1, 3, 6, 7, 14, 33, 34, 35, 36, 37, 38, 40, 41, 42, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 69, 70, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 85, 86, 87, 96], "output_unintegrated_reflect": 54, "outright": 78, "outset": 76, "outsid": [2, 14, 38, 66], "outward": [76, 78], "over": [0, 1, 11, 16, 18, 40, 52, 53, 59, 60, 69, 72, 73, 74, 76, 81, 82, 84, 86, 87], "overal": [18, 40, 41, 44, 51, 53, 54, 58, 59, 60, 72, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 96], "overbias": 63, "overinfl": 1, "overlai": 74, "overlaid": 51, "overlap": [46, 53, 74, 82, 86, 87, 88], "overlaps_bord": [11, 53], "overlaps_filt": 54, "overload": [14, 74, 79, 81, 82, 84, 85, 86], "overparameteris": [1, 84], "overrid": [4, 14, 18, 41, 43, 45, 47, 51, 52, 53, 54, 58, 59, 60, 66, 72, 75, 81, 83], "overridden": [14, 52], "overview": 1, "overwrit": [23, 25, 38, 52, 81, 84], "overwrite_existing_model": 63, "overwrite_from_phil": 23, "overwritten": 74, "owen": 95, "own": [0, 4, 53, 59, 60, 63, 74, 75, 76, 83], "owner": 92, "oxford": 2, "oxid": 95, "p": [0, 2, 3, 11, 18, 40, 48, 69, 70, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95, 96], "p1": [18, 22, 53, 73, 74, 76, 82, 86, 96], "p1_model": 83, "p2": [73, 82, 86], "p21": [73, 86], "p21212": 73, "p212121": 73, "p22121": 85, "p222": [73, 85, 88], "p2221": 73, "p4": [76, 81, 96], "p41212": 84, "p43212": [53, 76], "p4p": [70, 76, 88], "p6m": 81, "p6m_60_panel": 81, "p_cc_given_": 18, "p_cc_given_not_": 18, "p_s_given_cc": 18, "paciorek": 2, "packag": [0, 2, 4, 9, 91, 95, 97], "packed_u_accessor": 14, "pad": [17, 23, 41, 45, 51, 54, 81], "page": [11, 18, 48, 53, 73, 74, 78, 79], "pai": [74, 76, 87], "pair": [1, 2, 14, 18, 23, 34, 40, 43, 48, 53, 55, 63, 66, 72, 73, 75, 76, 78, 82, 84, 86], "pairwis": [11, 39, 40, 72, 76], "palei": 0, "panel": [3, 14, 23, 38, 45, 46, 47, 50, 51, 52, 53, 54, 55, 59, 60, 73, 74, 75, 76, 81, 82, 86, 87], "panel_param": 23, "paper": [74, 75, 95], "parallax": [47, 50, 51, 52], "parallax_correct": 52, "parallaxcorrectedpxmmstrategi": [3, 82, 86], "parallel": [1, 2, 16, 24, 35, 38, 48, 81, 82, 83, 86, 87, 95, 97], "parallel_map": 83, "parallelepip": [53, 59, 60], "param": [4, 6, 11, 12, 14, 15, 16, 18, 21, 22, 23, 25, 26, 29, 30, 31, 33, 54, 83], "param_report": 14, "paramet": [1, 2, 4, 11, 12, 14, 15, 16, 17, 18, 19, 21, 22, 23, 24, 25, 26, 29, 30, 31, 33, 73, 74, 75, 81, 82, 83, 84, 85, 86, 87, 88, 96], "parameter_correlation_plot": 14, "parameter_esd": 4, "parameter_t": 59, "parameter_valu": 63, "parameter_vector_norm": 14, "parameteris": [1, 2, 14, 15, 53, 59, 60, 73, 74, 75, 81, 82, 83, 86, 96], "parameterreport": 14, "parameters_dict": [4, 15], "parametr": 98, "parent": [75, 87], "parenthes": 46, "pari": 11, "park": 95, "parkhurst": [0, 11, 75, 95, 98], "pars": [4, 6, 33], "parse_arg": [6, 33], "parse_known_arg": 33, "parser": [6, 33], "part": [1, 2, 14, 47, 53, 59, 60, 73, 74, 80, 81, 82, 83, 84, 86, 87, 96], "parti": [0, 9], "partial": [1, 3, 18, 40, 44, 46, 53, 59, 60, 63, 69, 70, 72, 74, 77, 81, 82, 84, 85, 86, 95], "partial_data": 26, "partial_set": 26, "partiality_cutoff": [44, 63, 72, 82, 84, 86], "partiality_threshold": [1, 33, 40, 44, 69, 70], "particular": [2, 4, 26, 47, 53, 59, 60, 74, 76, 87, 92, 96], "particularli": [47, 74, 75, 78, 83, 84, 87, 88, 96], "pascal": 95, "pass": [6, 7, 14, 18, 23, 44, 45, 46, 49, 51, 52, 63, 74, 76, 77, 81, 82, 83, 84, 85, 86, 88], "passag": 35, "past": [38, 54, 74, 81], "patch": 7, "paterson": 95, "path": [1, 4, 7, 26, 34, 35, 36, 37, 40, 43, 44, 45, 47, 48, 49, 50, 51, 52, 53, 54, 55, 59, 60, 61, 62, 63, 64, 67, 68, 69, 72, 74, 81, 83, 84, 91], "pathlib": 4, "patholog": 84, "pathologi": 72, "pattern": [37, 73, 75, 77, 78, 81, 82, 83, 84, 86, 95, 97], "patterson": [18, 40, 73, 76, 82, 84, 85, 86, 87, 95], "patterson_group": 18, "paus": 78, "pb": [47, 54], "pcm": 82, "pd": 95, "pdb": [2, 40, 44, 51, 61, 63, 72, 74, 77, 82, 84], "pdb_version": 44, "pdf": [18, 53, 57, 59, 60, 71], "peachi": 25, "peak": [11, 47, 51, 53, 74, 82, 85, 86, 87, 94], "peak_search": 53, "peak_volume_cutoff": [11, 53], "peakcentroiddistancefilt": [16, 19], "peakfind": 47, "pearson": 18, "pearson_correlation_coeffici": 18, "peculiar": 75, "pedest": [23, 26, 52, 82, 86], "penros": 14, "peptid": 95, "per": [1, 14, 15, 24, 35, 36, 38, 40, 41, 43, 47, 51, 53, 54, 58, 59, 60, 63, 67, 72, 73, 74, 76, 79, 82, 83, 85, 86, 87, 93, 96], "per_degre": [41, 51, 54, 58], "per_imag": [14, 67], "per_image_statist": 47, "per_width": 14, "percent": [33, 53, 77], "percent_bandwidth": 53, "percentag": [33, 54, 63, 72], "percentil": [11, 53], "perfectli": 35, "perform": [0, 2, 6, 9, 11, 14, 15, 18, 37, 40, 41, 43, 44, 53, 54, 56, 59, 60, 63, 68, 72, 73, 74, 78, 81, 82, 83, 84, 85, 86, 87, 88, 90, 96], "perhap": [1, 44, 78], "period": [4, 11, 82, 86, 87], "perl": 83, "permiss": [7, 54, 92], "permit": 92, "pernici": 78, "perpendicular": [34, 68, 76], "perraki": 97, "perspect": [88, 97], "pet": 44, "peter": 95, "pflugrath": [0, 97], "pfuetzner": 95, "ph": 95, "pharmaceut": 73, "phase": [11, 73, 77], "phaser": 73, "phenix": 72, "phi": [2, 14, 22, 25, 52, 53, 59, 60, 63, 68, 75, 78, 81, 82, 83, 86, 87], "phi_angl": 68, "phic": [81, 82, 83, 86], "phil": [0, 3, 4, 6, 7, 11, 12, 14, 15, 18, 21, 23, 25, 29, 31, 33, 51, 54, 63, 74, 75, 83, 98], "phil_help": 11, "phil_scop": [4, 6, 11, 15, 83], "philcommandpars": [32, 33], "philo": 95, "philosophi": 0, "phio": [81, 82, 83, 86], "photon": [74, 95, 97], "photosynthet": 95, "photosystem": 95, "physic": [1, 2, 4, 15, 35, 63, 72, 82, 84, 86, 87, 88, 95, 97], "physicalscalingmodel": 15, "pick": [74, 75, 77, 87], "pickl": [11, 16, 24, 38, 47, 51, 75], "pictur": 73, "pierr": 83, "pilatu": [4, 48, 78, 81, 82, 86, 87], "pim": [76, 84, 85], "pink": [11, 82, 86], "pink_index": 53, "pinkindex": 11, "pipelin": [77, 79, 82, 84, 86, 95], "pixel": [2, 3, 16, 23, 31, 36, 41, 42, 45, 47, 50, 51, 52, 53, 54, 59, 60, 62, 73, 74, 78, 79, 81, 82, 85, 86, 87, 90, 96, 97], "pixel_label": 16, "pixel_list_to_reflection_t": [16, 19], "pixel_list_to_shoebox": [16, 19], "pixel_s": [3, 23, 52, 74, 82, 86], "pixellistlabel": 16, "pixels1": 36, "pixels2": 36, "pixels_per_bin": 62, "pkg": 91, "pkg_resourc": 4, "pkg_util": 4, "place": [14, 24, 34, 44, 52, 73, 75, 77, 81, 82, 86], "plai": [74, 82, 86], "plan": 94, "plane": [2, 21, 34, 53, 54, 59, 60, 68, 74, 75], "plane_norm": 68, "plate": [35, 76, 82, 83, 86, 87], "platform": 91, "platon": 73, "plausibl": [82, 86], "pleas": [4, 9, 63, 72, 77, 78, 79, 80, 81, 83, 84, 85, 86, 87, 88, 90], "plenti": 81, "plop": 73, "plot": [1, 12, 15, 31, 57, 59, 62, 63, 67, 68, 70, 73, 74, 76, 81, 82, 83, 84, 85, 86, 87, 96], "plot_centroid_analysi": [53, 59, 60], "plot_displac": 11, "plot_histogram": 11, "plot_model_compon": 15, "plot_scaling_model": 15, "plot_scan_varying_model": [71, 74], "plot_search_scop": 64, "plotli": 15, "plu": [3, 14, 15, 30, 82, 86, 87], "plug": [73, 75], "plugin": 4, "pmatrix": 2, "pmc": [73, 74, 75, 95], "pmc3382516": 95, "pmc3448510": 95, "pmc3689530": 95, "pmc3732582": 95, "pmc4008696": 95, "pmc4052861": 95, "pmc4052878": 95, "pmc4070675": 95, "pmc4119952": 95, "pmc4151126": 95, "pmc4156696": 95, "pmc4188007": 95, "pmc4248568": 95, "pmc4257623": 95, "pmc4260607": 95, "pmc4273327": 95, "pmc4321488": 95, "pmc4321489": 95, "pmc4344359": 95, "pmc4397907": 95, "pmc4403592": 95, "pmc4461207": 95, "pmc4607316": 95, "pmc4791177": 95, "pmc4822564": 95, "pmc5139990": 95, "pmc5619854": 95, "pmc5930348": 95, "pmc5947772": 95, "pmc6096487": [75, 95], "pmc6130462": 95, "pmc6450062": 95, "pmc7137103": 95, "pmc7737759": 73, "pmc8110528": 74, "pmc8313502": 73, "pmc8740827": 95, "pmc9159281": 95, "pmid": [73, 74, 75, 95], "png": [6, 11, 45, 57, 67, 68, 70, 76, 81, 83], "point": [2, 3, 7, 11, 14, 18, 38, 40, 44, 53, 54, 65, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93], "pointer": 26, "pointgroup": 53, "pointless": [18, 40, 44, 69, 75, 77, 84, 86], "pointless_combin": 75, "pointless_reindex_": 75, "poisson": [42, 78, 82, 86, 87], "pokeri": 6, "polar": [21, 38, 52, 82, 84, 86], "polarization_fract": [3, 21, 38, 52], "polarization_fraction_toler": 24, "polarization_norm": [3, 21, 38, 52], "polarization_normal_toler": 24, "polarization_plane_norm": 21, "polici": 14, "polish": 87, "polychromat": [11, 52, 53], "polychromaticbeam": 21, "polygon": [47, 50, 51], "polyhedrin": 95, "polynomi": [43, 72], "poon": [0, 53, 59, 60], "poor": [75, 77, 80, 81, 82, 83, 86, 87], "poorer": [1, 84], "poorli": [1, 47, 53, 59, 60, 73, 74, 76, 84, 87], "pop": 87, "popul": [15, 26, 33, 84, 96], "port": 49, "posit": [0, 1, 2, 3, 11, 14, 15, 33, 47, 53, 54, 59, 60, 63, 64, 66, 69, 72, 73, 74, 75, 76, 78, 79, 81, 82, 84, 85, 86, 87, 88], "posix": 75, "possibl": [0, 1, 2, 4, 11, 18, 33, 34, 40, 53, 56, 59, 60, 69, 73, 74, 75, 76, 77, 78, 79, 82, 83, 84, 85, 86, 87, 88, 92], "possibli": [14, 18, 37, 76, 77], "post": [12, 82, 86, 87, 90, 95], "potenti": [14, 53, 59, 60, 61, 72, 73, 76, 82, 86], "pothineni": 95, "potter": 73, "powder": [45, 46, 47, 50, 51, 74, 75, 81, 82, 85, 86], "powder_arc": 51, "powel": [0, 98], "poweleit": 73, "power": [11, 53, 76, 82, 86], "pp": 0, "pr": 74, "practic": [2, 14, 73, 74, 77, 82, 84, 86, 87, 89], "pre": [1, 12, 82, 86, 87], "preced": 14, "precis": [44, 82, 86], "pred_param": 14, "predict": [3, 11, 14, 16, 17, 40, 41, 44, 51, 53, 54, 59, 60, 71, 74, 75, 81, 82, 83, 84, 85, 86, 87], "predict_for_free_reflect": 14, "predict_for_index": 14, "predict_for_reflection_t": 14, "predict_reflect": 51, "prediction_parameteris": 14, "predictionparamet": 14, "predictionparameteris": 14, "predictor": [14, 17], "prefer": [9, 18, 40, 47, 60, 69, 72, 74, 76, 81, 82, 83, 84, 86, 87], "prefilt": 15, "prefix": [7, 12, 44, 45, 47, 53, 59, 60, 83, 91], "preliminari": 72, "prepar": [7, 14, 63, 73, 76, 79, 83, 88], "prepare_for_step": 14, "preprocess": [47, 51, 82, 84, 86], "prerequisit": 9, "preselect": [82, 86], "presenc": [18, 40, 77, 84, 88, 95], "present": [0, 14, 15, 18, 33, 40, 44, 46, 53, 59, 60, 61, 66, 71, 72, 76, 77, 78, 81, 82, 84, 85, 86, 87, 88, 90, 99], "preserve_ord": 83, "press": [2, 78, 87], "pressur": 35, "presum": [23, 74], "pretend": 4, "pretti": [18, 78, 87], "preview": [82, 86, 87], "previou": [63, 75, 76, 81, 82, 84, 86, 87], "previous": [15, 82, 84, 86], "prf": [3, 40, 54, 74, 81, 82, 84, 85, 86], "primari": [25, 33, 34, 74], "primarili": [11, 44, 53, 82, 86, 87], "prime": 2, "primit": [11, 53, 60, 73, 77, 78, 82, 86, 87, 88], "princip": [14, 40, 76, 84], "principl": [11, 21, 34], "print": [6, 7, 12, 14, 18, 33, 46, 47, 57, 60, 65, 74, 78, 82, 83, 86, 87], "print_exp_rmsd_t": 14, "print_funct": 4, "print_help": 6, "print_out_of_sample_rmsd_t": 14, "print_panel_rmsd_t": 14, "print_stats_on_match": 14, "print_step_t": 14, "print_tim": 33, "printabl": 71, "printf": 76, "prior": [2, 11, 54, 74, 82, 86, 87, 88, 92], "prioriti": 52, "privat": [9, 14], "probabl": [1, 11, 18, 40, 41, 51, 53, 54, 58, 59, 60, 73, 76, 82, 84, 85, 86], "probe": [21, 52, 82, 86], "problem": [0, 14, 74, 77, 78, 79, 82, 83, 84, 86, 87, 93], "problemat": 14, "proc": [74, 75, 95], "proce": [53, 59, 60, 76, 78, 82, 84, 85, 86, 87, 88, 93], "procedur": [11, 40, 72, 74, 82, 83, 84, 86, 87], "proceed": [0, 11, 74, 76, 77], "process": [0, 1, 3, 7, 12, 14, 16, 31, 38, 40, 41, 44, 47, 48, 51, 52, 53, 54, 58, 59, 60, 63, 71, 72, 75, 77, 78, 79, 80, 81, 82, 84, 85, 88, 89, 95, 97], "process_includ": 6, "process_sequ": 83, "process_teha": 83, "processor": [12, 14, 16, 48, 54, 72, 82, 83, 86, 87], "processor2d": [12, 19], "processor3d": [12, 19], "processorclass": 12, "processorflat3d": [12, 19], "processorsingle2d": [12, 19], "processorstil": [12, 19], "processs": 84, "procur": 92, "produc": [7, 38, 44, 53, 54, 59, 60, 66, 74, 75, 77, 78, 81, 82, 83, 84, 86, 87, 96], "product": [2, 11, 92], "product_nam": 33, "product_specific_finalize_instal": 33, "profil": [1, 3, 12, 24, 27, 31, 32, 35, 40, 41, 44, 47, 51, 54, 58, 63, 72, 74, 77, 78, 81, 82, 83, 84, 85, 86, 87, 94], "profile_fitt": 12, "profile_model": [3, 4, 19, 32], "profile_model_report": 12, "profile_validation_report": 12, "profilemodelfactori": [27, 28], "profilemodellerexecutor": [12, 19], "profilevalidatorexecutor": [12, 19], "profit": 92, "program": [1, 3, 7, 8, 34, 35, 36, 37, 40, 41, 42, 44, 46, 47, 50, 51, 52, 53, 54, 55, 58, 60, 61, 62, 63, 69, 72, 73, 74, 77, 78, 79, 82, 83, 84, 85, 86, 87, 88, 96, 99], "progress": [18, 33, 85, 94], "progressbar": [32, 33], "progressbartim": [32, 33], "prohibit": 1, "project": [0, 2, 11, 44, 45, 51, 63, 68, 76, 79, 83, 84, 85, 90, 95, 97, 98], "project_nam": [33, 44, 63], "project_root": 48, "project_src": 48, "promot": 92, "prompt": 74, "proper": [17, 33, 73], "properli": [7, 74, 75, 77, 78, 83, 84], "properti": [1, 2, 11, 14, 15, 18, 25, 26, 29, 33, 35, 47, 95], "proport": 74, "propos": [82, 86, 87], "prospect": 97, "proteas": 80, "protein": [63, 73, 74, 75, 82, 83, 95], "proteinas": 84, "protocol": [75, 83], "prototyp": 0, "provid": [0, 1, 4, 7, 11, 14, 15, 18, 23, 24, 33, 36, 38, 40, 43, 47, 50, 51, 52, 53, 54, 61, 63, 66, 69, 70, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 91, 92, 96, 97], "proxim": 53, "prudent": [74, 87], "pseudo": [77, 84], "pseudocentr": 78, "pseudoinvers": 14, "psi": [2, 14], "psi_i": 2, "psi_x": 2, "psi_z": 2, "pt": 73, "public": [0, 14, 74, 75], "publish": [0, 74, 82], "pull": [4, 87], "pure": [2, 14], "purpos": [59, 74, 77, 81, 82, 83, 86, 87, 92], "push": 74, "put": [7, 53, 74, 78], "pwd": 75, "px": [3, 47, 50, 51, 52, 73, 74, 78, 81, 82, 83, 85, 86], "px_mm": 23, "px_mm_strategi": 3, "px_sz": [53, 59, 60], "py": [4, 9, 73, 75, 83], "python": [0, 3, 4, 7, 9, 22, 23, 24, 25, 26, 79, 83, 95], "python2": 79, "q": [84, 85, 95], "q1": [81, 82, 83, 86], "q3": [81, 82, 83, 86], "qe": 3, "quad": [53, 75], "quadrat": 63, "qualiti": [1, 45, 48, 49, 72, 73, 74, 78, 81, 82, 84, 85, 86, 87, 95, 97], "quantil": [53, 59, 60], "quantiti": 6, "quantum": 3, "quarter": [81, 84, 87], "quasi": [18, 40, 69, 72, 84, 94], "quasi_random": [1, 63, 72], "queri": 14, "question": [76, 78, 80, 84], "quick": [1, 49, 63, 74, 81, 83], "quick_pars": 33, "quicker": 81, "quit": [11, 21, 44, 53, 73, 74, 75, 78, 84], "r": [0, 1, 2, 6, 11, 15, 18, 35, 40, 43, 47, 50, 51, 63, 69, 72, 73, 76, 77, 84, 85, 93, 95], "r01": [0, 90], "r_": [2, 18, 76], "r_0": 2, "r_anom": [73, 82, 84, 86], "r_free_arrai": 33, "r_free_flag": 72, "r_mea": [73, 82, 84, 85, 86], "r_mrg": [73, 82, 84, 85, 86], "r_pim": [73, 82, 84, 85, 86], "ra": 95, "rad": [3, 14, 53, 59, 60, 84], "radial": [11, 47], "radial_profil": 47, "radialaverag": [10, 19], "radian": [11, 53, 54], "radiat": [1, 72, 73, 74, 78, 81, 82, 84, 86, 87, 95], "radiu": [53, 64], "rahaman": 74, "rai": [2, 11, 22, 33, 35, 52, 73, 74, 78, 82, 86, 90, 94, 95, 97], "rainbow": [45, 51], "rais": [15, 52, 53, 59, 60], "ram": 81, "ran": [76, 83], "random": [14, 38, 53, 54, 59, 60, 63, 64, 72, 81, 84], "random_se": [53, 54, 59, 60], "randomli": [63, 72, 82, 84, 86, 97], "rang": [1, 15, 16, 26, 47, 50, 51, 52, 53, 54, 59, 60, 63, 64, 66, 69, 72, 74, 79, 82, 83, 84, 85, 86, 87], "rank": 40, "ranom": 84, "rapid": [0, 96, 97], "rapidli": 76, "raster": [48, 76], "rate": [81, 83, 87, 97], "rather": [1, 2, 7, 63, 74, 75, 76, 78, 81, 82, 83, 86, 87, 88, 97], "ratio": [14, 40, 76, 84], "raw": [3, 9, 44, 45, 47, 48, 55, 65, 73, 75, 82, 86, 87], "rawdata": 48, "rawdescriptionhelpformatt": 33, "rb": 95, "re": [16, 34, 48, 60, 61, 72, 75, 76, 83, 84, 85], "reach": [14, 53, 59, 60, 97], "read": [1, 2, 3, 4, 5, 23, 24, 25, 26, 29, 33, 40, 55, 73, 74, 78, 82, 83, 84, 85, 86, 87], "read_experi": [6, 33], "read_experiments_from_imag": 33, "read_fil": 33, "read_reflect": [6, 33], "readabl": 3, "reader": [26, 32, 33, 71, 74, 78], "readi": [7, 44, 75, 83, 87], "real": [2, 4, 11, 76, 77, 78, 81, 82, 83, 86, 87, 95, 96], "real_space_a": [3, 22, 30], "real_space_b": [3, 22, 30], "real_space_c": [3, 22, 30], "real_space_grid_search": [4, 11, 53, 87, 96], "realist": 76, "realiti": 83, "realli": [73, 76, 81, 83], "realspacegridsearch": 11, "reason": [1, 2, 53, 59, 60, 73, 74, 75, 76, 77, 78, 82, 83, 84, 85, 86, 88], "reason_for_termin": 14, "rebuild": 77, "recent": [33, 79, 84, 90, 97], "receptor": 74, "reciproc": [1, 2, 3, 4, 11, 14, 18, 22, 31, 34, 40, 41, 44, 51, 53, 54, 58, 72, 74, 77, 78, 82, 84, 86, 87, 88], "reciprocal_lattice_point": 11, "reciprocal_lattice_vector": [4, 11], "reciprocal_lattice_view": [74, 76, 77, 78, 81, 82, 86, 87, 88], "reciprocal_spac": [41, 51, 54, 58], "reciprocal_space_grid": 53, "recognis": [24, 74, 78], "recombin": 93, "recommend": [1, 3, 7, 53, 59, 60, 63, 73, 74, 75, 82, 84, 85, 86], "reconcil": 2, "reconstruct": 11, "record": [2, 4, 14, 15, 44, 53, 59, 60, 73, 74, 76, 77, 78, 79, 81, 82, 83, 85, 86, 88], "record_intensity_combination_imid": 15, "recov": 35, "recreat": 75, "rectangl": [47, 50, 51, 75], "rectangular": 14, "recycle_unindexed_reflections_cutoff": 53, "red": [45, 73, 74, 82, 86, 87], "redefin": 2, "redistribut": 92, "reduc": [1, 2, 14, 15, 35, 40, 45, 47, 51, 53, 59, 60, 66, 72, 73, 76, 82, 83, 86, 87, 88], "reduct": [14, 53, 77, 80, 82, 86, 87, 97], "redund": [84, 85], "ree": 0, "ref": [10, 43, 72], "refelct": 63, "refer": [2, 8, 14, 18, 21, 23, 25, 29, 37, 38, 40, 41, 43, 51, 52, 54, 57, 58, 61, 62, 63, 66, 71, 72, 75, 81, 82, 86, 87, 89, 96], "reference_from_experi": [38, 81, 83, 93], "reference_geometri": [52, 75], "reference_miller_set": 18, "reference_model": [40, 61, 63], "reference_profil": 54, "reference_spot": 46, "refin": [1, 3, 4, 11, 15, 18, 19, 32, 38, 41, 44, 46, 51, 53, 54, 57, 58, 60, 62, 63, 70, 71, 72, 76, 77, 78, 79, 80, 84, 89, 95, 96, 98], "refine_all_candid": 53, "refine_bravais_set": [71, 73, 74, 75, 77, 78, 82, 85, 86, 87, 88], "refine_candidates_with_known_symmetri": 53, "refine_shel": 53, "refined_cel": [70, 88], "refined_experi": 75, "refined_lev0": 81, "refined_lev1": 81, "refinement_ord": 63, "refinement_param": 11, "refinement_protocol": 53, "refinerfactori": [14, 19], "refineri": [14, 19, 53, 59, 60, 63], "refl": [1, 3, 6, 35, 37, 38, 40, 41, 43, 44, 46, 47, 51, 53, 54, 56, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 69, 70, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 88, 93, 96], "reflect": [2, 4, 6, 10, 11, 12, 14, 15, 16, 17, 18, 31, 33, 35, 37, 38, 40, 41, 43, 44, 46, 47, 51, 53, 54, 56, 58, 59, 60, 61, 63, 64, 65, 66, 68, 69, 70, 72, 73, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 89, 96, 98], "reflection_file_object_list": 33, "reflection_manag": 14, "reflection_predictor": 17, "reflection_select": [1, 63, 72], "reflection_t": [3, 4, 11, 12, 14, 15, 16, 33, 83], "reflection_table_selector": 54, "reflectionmanag": [12, 14, 19], "reflectionmanagerfactori": [14, 19], "reflectionpredictor": [17, 19], "reflections_": [88, 93], "reflections_0": [38, 40, 84, 88], "reflections_1": [38, 40, 84, 88], "reflections_2": [40, 84, 88], "reflections_3": [40, 84, 88], "reflections_after_outlier_reject": 14, "reflections_and_experiments_from_fil": [32, 33], "reflections_filenam": [38, 66], "reflections_per_bin": [43, 72], "reflections_per_degre": [41, 51, 53, 54, 58, 59, 60], "refman": 14, "refresh": 4, "regard": [74, 87], "regardless": 1, "region": [2, 11, 16, 46, 47, 56, 74, 75, 77, 81, 84, 87], "region_of_interest": [16, 47], "regist": 4, "registri": 4, "regular": [1, 47, 54, 63, 66, 69, 72, 76, 78, 81, 85, 96], "regular_grid": [41, 51, 54, 58], "rehanek": 95, "reindex": [18, 24, 40, 53, 60, 71, 72, 73, 74, 75, 76, 77, 78, 82, 84, 85, 86, 87, 88], "reindex_to_refer": 18, "reintegr": 54, "reinvent": 0, "reject": [1, 14, 15, 43, 46, 47, 50, 51, 53, 54, 59, 60, 63, 72, 73, 81, 82, 83, 84, 85, 86, 87], "reject_fract": 46, "reject_outli": 15, "rejectiob": 15, "rejector": [53, 54, 59, 60], "rel": [1, 11, 15, 18, 47, 53, 57, 62, 63, 72, 76, 81, 82, 83, 84, 86, 87, 88], "relat": [1, 2, 14, 37, 39, 53, 59, 60, 73, 76, 77, 78, 82, 83, 84, 86, 87], "relationship": [2, 3, 52], "relative_b_correct": 63, "relative_length_toler": [11, 18, 40, 53, 69, 72], "relative_to_complete_set": 72, "relative_to_static_orient": [57, 62], "releas": 7, "relev": [14, 43, 44, 82, 84, 86, 87], "reli": 93, "reliabl": [63, 73, 82, 84, 86, 88], "relocat": 62, "relp": [53, 59, 60], "remain": [0, 2, 11, 14, 38, 53, 54, 59, 60, 74, 75, 78, 82, 85, 86, 87], "remap": 16, "rememb": [73, 78, 81, 83], "remind": [1, 81], "remot": [62, 79], "remov": [1, 4, 35, 40, 50, 53, 54, 59, 60, 63, 66, 70, 72, 73, 74, 76, 82, 83, 84, 85, 86, 87, 93], "remove_on_experiment_identifi": 24, "remove_profile_fitting_failur": 72, "remove_sources_default": 33, "renumb": 33, "reopen": 24, "repeat": [38, 47, 63, 73, 74, 75, 81, 83, 84, 87, 96], "repeatedli": 76, "repetit": 63, "replac": [9, 24, 38, 52, 73, 74, 75, 77, 83], "replot": [59, 70], "report": [1, 12, 14, 40, 42, 48, 54, 63, 67, 69, 70, 71, 74, 76, 78, 84, 85, 87, 90, 96], "report_progress": 14, "repositori": [4, 9, 53, 59, 60, 75], "repredict_onli": 53, "repres": [2, 12, 40, 44, 52, 81, 82, 86, 87], "represent": [2, 15, 18, 52, 84], "reprint": [73, 74, 75, 95], "reprocess": [73, 86, 87], "reproduc": [74, 75, 77, 82, 83, 86, 87, 92], "request": [4, 14, 26, 43, 48, 53, 59, 60, 78, 81, 90], "requir": [4, 7, 11, 14, 15, 18, 44, 52, 53, 54, 59, 60, 62, 73, 74, 75, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 90, 93, 95, 97], "rerun": [83, 84, 85, 88], "rescal": [72, 82, 86], "rescale_after_resolution_cutoff": 72, "rescu": 83, "research": [90, 92], "reserv": 92, "reset": [14, 63, 73], "reset_accepted_reflect": 14, "reset_error_model": 63, "reset_scan_point": 25, "residu": [14, 53, 59, 60, 76, 81, 82, 86, 87], "resiz": 87, "resolut": [1, 11, 17, 18, 37, 38, 40, 41, 43, 44, 45, 46, 47, 48, 49, 50, 51, 53, 54, 60, 63, 67, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 95], "resolution_analysi": 67, "resolution_depend": 63, "resolution_filter_from_arrai": [18, 19], "resolution_filter_from_reflections_experi": [18, 19], "resolution_r": 45, "resolution_rang": [47, 50, 51], "resolv": [72, 74, 76, 82, 86, 87], "resolve_indexing_ambigu": 72, "resourc": 1, "respect": [18, 35, 39, 63, 76, 79, 84], "respons": [47, 49, 74], "rest": [1, 11, 40, 74, 84], "restart": 14, "restrain": [1, 53, 59, 60, 63, 75], "restraint": [14, 53, 59, 60, 63, 74, 75, 83, 88], "restraints_param": 14, "restraints_parameteris": 14, "restrict": [44, 53, 59, 60, 83, 84], "result": [1, 2, 11, 14, 15, 18, 35, 37, 38, 39, 40, 42, 43, 44, 51, 53, 57, 59, 60, 63, 64, 66, 67, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 88, 93, 96], "retain": [38, 44, 54, 76, 92], "retrospect": 97, "return": [1, 4, 6, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 29, 30, 31, 33, 49, 53, 59, 60, 74, 83, 87], "return_unhandl": 33, "reus": [0, 94], "reusabl": 2, "reveal": [74, 77], "revers": [4, 11, 25, 44, 78], "revis": [87, 95], "revisit": 76, "reweight": 63, "rewrit": 81, "rey": 95, "rf": 95, "rg": 95, "rho": 35, "rice": 73, "richard": 0, "rigaku": 23, "right": [2, 4, 35, 73, 74, 78, 81, 83, 92], "rigid": [53, 59, 60, 81], "rigor": 74, "rij": [18, 40, 72], "ring": [44, 45, 46, 47, 49, 50, 51, 53, 54, 74, 75, 81, 82, 84, 85, 86, 95], "riordan": [0, 95], "risk": 76, "rj": 95, "rl": 95, "rlp": [3, 44, 53], "rlp_mosaic": [41, 51, 54, 58], "rm": 84, "rmat": 33, "rmea": [63, 74, 76, 79, 82, 84, 86, 87, 88], "rmerg": [43, 72, 74, 76, 79, 82, 84, 86, 87, 88], "rmsd": [11, 14, 53, 59, 60, 63, 73, 74, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 96], "rmsd_cutoff": [11, 53, 59, 60], "rmsd_deltapsi": 14, "rmsd_i": [82, 84, 86], "rmsd_min_px": 53, "rmsd_name": 14, "rmsd_phi": [14, 81, 82, 83, 85, 86, 87], "rmsd_target_mm": 53, "rmsd_toler": 63, "rmsd_unit": 14, "rmsd_wavelength": 14, "rmsd_weight": [11, 53], "rmsd_x": [14, 73, 74, 78, 81, 82, 83, 85, 86, 87], "rmsd_xy": [82, 86], "rmsd_y": [14, 73, 74, 78, 81, 82, 83, 85, 86, 87], "rmsd_z": [73, 74, 78, 81, 82, 83, 85, 86], "rmsds_for_experi": 14, "rmsds_for_panel": 14, "rmsds_for_reflection_t": 14, "robert": 0, "robust": [53, 54, 59, 60, 76, 95], "rock": 74, "rodriguez": 95, "roi": 47, "room": [83, 95], "root": [4, 53, 59, 60, 74], "rossmann": 11, "rotat": [1, 2, 4, 6, 11, 14, 22, 25, 33, 34, 35, 38, 39, 47, 52, 53, 54, 57, 59, 60, 62, 63, 68, 72, 73, 74, 75, 76, 78, 81, 82, 84, 85, 86, 87, 93, 96, 97], "rotate_around_origin": [23, 25], "rotate_cryst": [32, 33], "rotation_angle_deg": 54, "rotation_axi": [3, 25, 38], "rotation_axis_toler": [24, 25], "rotation_matrix_differ": 11, "rotation_scan_manag": 14, "rotogram": 53, "rotogram_grid_point": 53, "rough": 78, "rougher": 87, "roughli": [11, 43], "round": [1, 53, 63, 72, 73, 74, 78, 79, 82, 84, 86], "rousseeuw": [53, 59, 60], "routin": [1, 63, 88], "row": 14, "rpim": [1, 74, 76, 79, 82, 84, 86, 87, 88], "rsmd": [14, 83], "rt_mx": 18, "rub": 2, "rubi": 83, "rule": [53, 59, 60], "run": [1, 4, 6, 7, 9, 14, 15, 16, 18, 38, 40, 43, 44, 48, 53, 55, 59, 60, 63, 73, 74, 75, 76, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 96], "run_lbfg": 14, "runtim": [4, 75], "runtimeerror": 11, "rupp": 2, "rw": 95, "s0": [6, 21, 23, 43], "s0021889810010782": [53, 59, 60], "s1": [3, 23, 41, 51, 54, 58], "s1600576714007626": 47, "s2053273319015559": 11, "s2059798317010348": 75, "sacrifici": 83, "sad": [44, 88], "sadab": 44, "saeed": 0, "sai": [7, 53, 59, 60, 78, 83, 87], "same": [1, 2, 11, 14, 23, 24, 36, 44, 54, 59, 61, 66, 70, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 87, 96], "sampl": [2, 11, 14, 18, 23, 35, 52, 53, 54, 59, 60, 73, 74, 76, 81, 82, 86, 87, 88], "sample_to_sourc": 21, "sample_to_source_dist": [21, 52], "sanchez": 95, "sandi": 95, "sandwich": 35, "sangwan": 95, "sanishvili": 95, "saniti": 53, "sar": 80, "satellit": 84, "satisfi": [81, 87], "satur": 45, "saturn": 23, "sauter": [0, 2, 11, 48, 53, 59, 60, 64, 95, 97], "sauter_poon": [53, 59, 60, 83], "save": [3, 38, 40, 41, 47, 50, 52, 54, 58, 63, 74, 75, 81, 82, 83, 84, 85, 86, 87, 88, 96], "save_coordin": 68, "saw": 73, "sawaya": 95, "sb": 95, "sbgrid": 74, "sc": 79, "sca": 72, "scalar": 11, "scale": [2, 3, 18, 19, 22, 24, 32, 35, 40, 43, 44, 45, 48, 56, 71, 72, 76, 78, 79, 80, 83, 89, 94, 95], "scale_and_filter_result": 63, "scale_compon": 4, "scale_correct": 1, "scale_interv": [1, 63, 87], "scale_rang": 44, "scalecomponentbas": 4, "scaled_unmerg": [43, 44, 76], "scaler": [15, 84], "scaling_model": 24, "scaling_model_ext": 4, "scaling_opt": 63, "scaling_refineri": 63, "scalingmodelbas": [4, 15], "scan": [2, 3, 4, 6, 14, 16, 17, 24, 25, 26, 27, 32, 38, 41, 44, 47, 48, 49, 51, 52, 53, 54, 57, 58, 59, 60, 63, 65, 66, 68, 69, 72, 73, 74, 76, 81, 82, 83, 85, 86, 87, 88, 93, 97], "scan_axi": [25, 52], "scan_margin": [14, 53, 59, 60], "scan_rang": [16, 47, 54], "scan_step": [41, 51, 54, 58], "scan_toler": [24, 33], "scan_vari": [41, 51, 53, 54, 58, 59, 60, 73, 74, 75, 81, 82, 83, 93], "scanaxi": 25, "scanfactori": [27, 29], "scanvaryingrefin": [14, 19], "scapin": 73, "scatter": [1, 2, 47, 53, 59, 60, 63, 74, 82, 86, 87, 95], "scene": 97, "sceptic": 78, "schafer": 95, "schemat": 35, "scheme": [14, 63, 82, 86, 87], "schlicht": 95, "school": 76, "schuermann": 0, "sci": [73, 95], "scienc": [0, 33, 79, 82, 90, 95], "scientif": 94, "scientist": 83, "scipi": [18, 40, 72], "scisoft": [33, 79, 82], "scitbx": [4, 6, 10, 11, 12, 14, 18, 22, 23, 24, 25, 26, 40, 72], "scope": [11, 12, 15, 33, 37, 53], "scope_extract": [14, 18, 21], "score": [1, 11, 18, 40, 63, 69, 73, 76, 77, 79, 82, 84, 85, 86, 87, 88], "score_by_fraction_index": 11, "score_by_rmsd_xi": 11, "score_by_volum": 11, "score_vector": 11, "scorecorrelationcoeffici": [18, 19], "scoresubgroup": [18, 19], "scoresymmetryel": [18, 19], "scratch": [9, 79, 83, 86], "screen": [82, 86], "screw": [84, 85], "script": [4, 6, 7, 9, 33, 38, 76, 83], "scroll": [73, 87], "sd": [82, 86, 88], "se": 95, "seamless": 0, "search": [11, 29, 37, 38, 53, 59, 60, 64, 74, 77, 78, 83, 85, 96], "search_beam_posit": [71, 78], "search_depth": 53, "search_direct": 11, "search_vector": 11, "second": [1, 18, 34, 73, 77, 78, 82, 83, 86, 87], "secondari": 72, "sect": 2, "section": [1, 3, 74, 76, 77, 82, 86, 87], "see": [1, 2, 7, 9, 11, 18, 47, 48, 53, 54, 59, 60, 63, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 91, 96], "seed": [18, 40, 53, 54, 59, 60, 64, 69, 72], "seed_dataset": 18, "seem": [1, 44, 74, 81, 83], "seen": [75, 81, 82, 86, 87], "seibert": 95, "sel": 14, "select": [1, 6, 11, 14, 15, 38, 40, 41, 43, 46, 51, 53, 54, 58, 59, 60, 63, 72, 74, 76, 78, 82, 84, 86, 87, 88], "select_good_intens": 46, "select_on_experiment_identifi": 24, "selection_used_for_refin": 14, "self": [4, 6, 12], "sellberg": 95, "seltzer": 35, "semi": 85, "semin": 0, "semisynthetic_multilattice_data": 85, "semisynthetic_multilattice_data_2": 85, "sens": 45, "sensibl": [1, 76, 82, 86, 87, 88], "sensit": [0, 11, 40, 84], "sensor": [2, 23], "sensor_pad": [82, 86], "sensor_unknown": 3, "sep": 95, "separ": [1, 14, 15, 38, 40, 43, 47, 53, 54, 59, 60, 63, 70, 72, 73, 74, 75, 81, 82, 83, 85, 86, 93], "separate_block": [53, 59, 60], "separate_experi": [53, 59, 60], "separate_fil": 54, "separate_imag": [53, 59, 60], "separate_independent_set": 59, "separate_panel": [53, 59, 60], "septemb": 99, "sequenc": [2, 3, 15, 16, 24, 26, 30, 36, 47, 52, 53, 54, 59, 60, 63, 66, 78, 79, 81, 82, 83, 85, 86, 88, 96], "sequence_": 83, "sequence_00": 83, "sequence_01": 83, "sequence_02": 83, "sequence_03": 83, "sequence_04": 83, "sequence_08": 83, "sequence_09": 83, "sequence_11": 83, "sequence_12": 83, "sequence_13": 83, "sequence_14": 83, "sequence_16": 83, "sequence_17": 83, "sequence_19": 83, "sequence_20": 83, "sequence_21": 83, "sequence_22": 83, "sequence_23": 83, "sequence_24": 83, "sequence_25": 83, "sequence_26": 83, "sequence_27": 83, "sequence_28": 83, "sequence_29": 83, "sequence_31": 83, "sequence_32": 83, "sequence_33": 83, "sequence_35": 83, "sequence_38": 83, "sequence_39": 83, "sequence_40": 83, "sequence_41": 83, "sequence_42": 83, "sequence_43": 83, "sequence_44": 83, "sequence_45": 83, "sequence_46": 83, "sequence_47": 83, "sequence_48": 83, "sequence_50": 83, "sequence_53": 83, "sequence_54": 83, "sequence_55": 83, "sequence_57": 83, "sequence_58": 83, "sequence_59": 83, "sequence_60": 83, "sequence_61": 83, "sequence_62": 83, "sequence_63": 83, "sequence_64": 83, "sequence_65": 83, "sequence_66": 83, "sequence_67": 83, "sequence_68": 83, "sequence_69": 83, "sequence_70": 83, "sequence_71": 83, "sequenti": [39, 74], "seri": [0, 11, 53, 83, 97], "serial": [4, 15, 24, 27, 32, 53, 59, 60, 74, 83, 90, 95, 96, 97], "serialis": 24, "serlial": 83, "serv": 79, "server": [9, 49, 71], "servic": [73, 92], "session": [9, 97], "set": [1, 2, 3, 6, 7, 11, 12, 14, 15, 16, 18, 26, 29, 30, 33, 34, 37, 38, 40, 42, 43, 44, 45, 46, 47, 50, 51, 52, 53, 54, 55, 56, 58, 59, 60, 61, 63, 65, 68, 69, 72, 73, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 90, 91, 93, 95, 96, 97], "set_angl": 25, "set_ax": 25, "set_beam": 26, "set_cholesky_factor": 14, "set_detector": 26, "set_dimens": 18, "set_domain_size_ang": 22, "set_domain_size_ang_valu": 53, "set_error_model": 15, "set_fixed_rot": 25, "set_format_class": 26, "set_goniomet": 26, "set_half_mosaicity_deg": 22, "set_last_cel": 14, "set_mosa": 22, "set_mosaic_half_deg_valu": 53, "set_nproc": 14, "set_param": 26, "set_rotation_axi": 25, "set_rotation_axis_datum": 25, "set_scaling_model_as_sc": 15, "set_scaling_model_as_unsc": 15, "set_scan": 26, "set_scan_varying_error": [53, 59, 60], "set_setting_rot": 25, "set_setting_rotation_at_scan_point": 25, "set_shoebox_background_valu": [10, 19], "set_templ": 26, "set_valid_image_rang": 15, "set_vendor": 26, "setting_rot": [38, 52], "setting_rotation_matrix": 25, "setting_rotation_toler": [24, 25], "setup": [4, 14, 33, 91], "setup_index": 11, "setup_mu": 14, "setuptool": 4, "seven": 75, "sever": [1, 9, 49, 76, 77, 82, 83, 84, 86, 87], "sfac": 73, "sfx": 74, "sge": [47, 54], "sgtbx": [11, 18, 22, 24, 53], "sh": [7, 74, 91], "shadow": [11, 45, 47, 51, 52, 58, 81], "shall": [75, 78, 84, 85, 92], "shape": [50, 63, 82, 86, 87, 88], "share": [3, 10, 12, 14, 23, 24, 25, 26, 38, 59, 63, 72, 83, 93], "shared_ptr": [10, 24, 26], "shell": [1, 7, 43, 47, 72, 73, 74, 75, 76, 84, 88], "shelx": [44, 70, 73, 88], "shelxd": 73, "shelxt": [73, 88], "shi": 95, "shift": [14, 53, 59, 60, 62, 78, 81, 82, 86, 87], "shoebox": [3, 10, 16, 38, 41, 47, 51, 54, 58, 63, 74, 82, 86, 87, 88], "shoebox_memori": 12, "shoeboxes_to_reflection_t": [16, 19], "shoeman": 95, "short": [3, 44, 49, 77, 81, 83], "short_capt": [40, 43, 47, 52, 53, 54, 59, 60, 63, 69, 72], "shortcut": 83, "shorter": [11, 21, 74], "shortest": 11, "shorthand": [47, 54, 63, 69, 72], "shortli": [82, 86], "shot": [53, 95], "should": [1, 2, 4, 7, 14, 15, 18, 25, 38, 44, 50, 54, 63, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 93], "show": [4, 22, 31, 33, 40, 45, 47, 51, 56, 71, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 87, 88, 96], "show_all_pix": 51, "show_all_reflection_data": 65, "show_beam_cent": 51, "show_centroid": 65, "show_correct": 65, "show_ctr_mass": 51, "show_diff_phil": [6, 33], "show_experi": 11, "show_flag": 65, "show_hkl": 51, "show_ice_r": 51, "show_identifi": 65, "show_index": 51, "show_integr": 51, "show_intens": 65, "show_mail_handle_error": 6, "show_mask": [45, 51], "show_max_pix": 51, "show_miller_indic": 51, "show_predict": 51, "show_profile_fit": 65, "show_raw": 65, "show_registri": 4, "show_resolution_r": 51, "show_rotation_axi": 51, "show_scan_vari": [22, 65], "show_shared_model": 65, "show_shoebox": 51, "show_threshold_pix": 51, "shown": [3, 4, 7, 52, 63, 73, 82, 83, 84, 86, 87], "shutterless": 97, "si": [73, 82, 84, 85, 86], "side": [14, 58, 74, 81], "sierecki": 74, "sierra": 95, "sig": [38, 40, 44, 82, 84, 85, 86], "sig_": 14, "sig_min": 14, "sigdano": 84, "sigf": [84, 85], "sigi": [38, 43, 54, 63, 72, 74, 79, 81, 82, 84, 85, 86], "sigimean": [84, 85, 86], "sigma": [1, 18, 40, 41, 51, 52, 53, 54, 58, 59, 60, 63, 69, 72, 74, 75, 76, 79, 82, 84, 85, 86, 87, 88], "sigma_": [45, 51], "sigma_b": [41, 45, 51, 54, 58], "sigma_background": 47, "sigma_cc": 18, "sigma_d": [82, 86, 87], "sigma_diverg": [3, 21, 52], "sigma_i": [81, 82, 86, 87], "sigma_m": [41, 51, 54, 58, 82, 86, 87], "sigma_m_algorithm": [41, 51, 54, 58], "sigma_phi_deg": 53, "sigma_strong": [47, 75], "sigma_tau": [43, 72], "sign": [14, 73, 82, 86, 87], "signal": [1, 74, 95], "signal_strength": 48, "signatur": [10, 12, 14, 22, 23, 24, 25, 26], "signific": [35, 38, 43, 47, 54, 63, 69, 72, 75, 81, 82, 83, 84, 86, 87], "significance_filt": [38, 54], "significance_level": 69, "significantli": [72, 73, 82, 84, 86, 87, 96], "silver": [51, 97], "similar": [1, 4, 15, 18, 40, 47, 52, 53, 74, 76, 77, 82, 83, 84, 85, 86, 87, 96], "similarli": 85, "simpl": [1, 4, 14, 15, 21, 23, 24, 31, 33, 47, 50, 51, 53, 54, 63, 72, 81, 83, 87], "simple1": [41, 51, 54, 58], "simple1angular1": [41, 51, 54, 58], "simple1angular3": [41, 51, 54, 58], "simple6": [41, 51, 54, 58], "simple6angular1": [41, 51, 54, 58], "simple_background_ext": 31, "simple_centroid_ext": 31, "simple_direct": 21, "simplebackgroundext": [31, 32], "simplecentroidext": [31, 32], "simplelbfg": [14, 19, 53, 59, 60, 63], "simplenormdevoutlierreject": 15, "simpli": [1, 2, 7, 14, 35, 40, 82, 83, 86, 87, 93], "simplic": 96, "simplifi": [2, 21], "simul": 95, "simultan": [74, 83, 87, 95], "sin": 2, "sinc": [2, 11, 35, 53, 54, 82, 86, 87, 88], "singl": [1, 2, 4, 11, 12, 14, 15, 16, 18, 24, 25, 29, 38, 40, 41, 45, 47, 48, 51, 52, 53, 54, 55, 58, 59, 60, 63, 66, 69, 70, 72, 74, 76, 77, 81, 82, 83, 85, 86, 87, 88, 93, 95], "single_axi": 25, "single_axis_goniometer_from_phil": 25, "single_axis_revers": [4, 25], "single_fil": 29, "single_file_indic": 26, "singleton": [40, 84], "singular": 14, "sit": 78, "site": [7, 75, 90], "situ": [76, 83, 84], "situat": [14, 74, 81, 82, 83, 86], "six": [75, 88], "size": [1, 4, 11, 18, 23, 26, 35, 38, 39, 41, 42, 43, 44, 45, 47, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 61, 62, 63, 64, 66, 68, 72, 73, 74, 81, 82, 84, 85, 86, 87, 96], "size_max": 52, "size_min": 52, "size_t": [12, 15, 16, 24, 26], "sj": 74, "sjsu": 18, "skinner": 95, "skip": [74, 96], "skip_deriv": 14, "slice": [53, 66, 74, 97], "slice_sequ": 71, "slide": 0, "slider": [73, 82, 86], "slightli": [29, 74, 81, 82, 83, 86, 87], "slippag": 2, "slope": [74, 76, 79, 82, 84, 86, 87, 88], "slow": [1, 23, 38, 44, 47, 50, 51, 52, 63, 72, 73, 74, 75], "slow_axi": [3, 23, 38, 52, 75, 82, 86], "slow_axis_toler": [23, 24], "slow_direct": 23, "slow_fast_beam_centr": 52, "sm": 95, "small": [1, 2, 11, 53, 59, 60, 76, 77, 78, 80, 81, 82, 84, 86, 87], "smaller": [18, 40, 53, 55, 59, 60, 66, 69, 72, 73, 74], "smallest": [14, 53, 59, 60], "smart_sigma": 54, "smeet": 0, "smith": 95, "smooth": [1, 82, 83, 86, 87], "smoother": [15, 53, 59, 60, 73, 75, 87], "smoothli": [1, 74, 82, 86, 87, 88, 93], "smtbx": 33, "smv": [73, 74], "snapshot": [11, 74, 95, 97], "snare": 95, "snippet": 81, "snow": 76, "so": [1, 2, 4, 11, 14, 16, 24, 26, 35, 40, 44, 53, 59, 60, 63, 70, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88], "soc": 95, "soft": 75, "softwar": [0, 2, 7, 11, 75, 82, 84, 85, 86, 90, 92, 94, 95, 97], "sokara": 95, "solid": 11, "solti": 95, "solut": [11, 14, 40, 53, 63, 73, 74, 75, 76, 77, 78, 79, 82, 83, 84, 85, 86, 87, 88], "solution_scor": 53, "solv": [77, 78, 82, 86, 87, 88], "solvent": 73, "some": [1, 2, 3, 4, 6, 7, 9, 14, 25, 33, 41, 53, 59, 60, 63, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 93, 94], "somehow": 76, "someth": [76, 78, 82, 83, 86], "sometim": [11, 52, 73, 82, 86], "somewhat": [7, 83], "somewher": 76, "song": 95, "sophist": [74, 82, 83, 87], "sorri": 93, "sort": [6, 33, 54, 78, 83, 84, 86], "sort_opt": 33, "sorted_": 75, "sorted_1": 75, "sorted_2": 75, "sorted_3": 75, "sorted_4": 75, "sorted_5": 75, "sorted_6": 75, "sorted_7": 75, "sourc": [0, 4, 9, 11, 12, 14, 15, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 30, 31, 33, 35, 44, 52, 78, 80, 81, 82, 83, 84, 85, 86, 87, 91, 92, 94, 95, 99], "source_nam": 44, "source_packag": 33, "source_short_nam": 44, "sourceforg": [79, 90], "space": [1, 2, 4, 7, 11, 14, 15, 18, 22, 31, 33, 37, 40, 41, 43, 44, 45, 46, 47, 50, 51, 53, 54, 58, 59, 60, 61, 63, 72, 73, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 96], "space_group": [11, 18, 22, 30, 33, 34, 39, 40, 43, 45, 46, 47, 50, 51, 53, 61, 69, 72, 73, 74, 77, 81, 82, 83, 85, 86, 88, 96], "space_group_hall_symbol": 3, "space_group_info": 11, "space_group_numb": 30, "space_group_symbol": 22, "spacegroup": [51, 75, 79], "spallat": 94, "span": 84, "spars": [14, 18, 40, 53, 59, 60, 81, 95, 96], "sparsegradientsmixin": [14, 19], "sparselevmar": [53, 59, 60], "spatial": 11, "speaker": 0, "special": [2, 4, 11, 51, 53, 59, 60, 63, 73, 74, 75, 76, 87, 92], "special_correct": 4, "specialcompon": 4, "specif": [0, 2, 4, 7, 53, 54, 59, 70, 74, 75, 76, 82, 83, 86, 87, 92], "specifi": [1, 2, 11, 14, 15, 33, 34, 36, 38, 43, 46, 47, 50, 51, 52, 53, 54, 59, 60, 61, 63, 64, 66, 68, 69, 70, 72, 74, 81, 83, 84, 91, 96], "spectral": 11, "spectroscopi": 95, "spectrum": 26, "speed": [0, 45, 53, 54, 59, 60, 73, 81, 82, 86, 87, 96, 97], "spell": 76, "spend": 77, "sphere": [14, 53, 59, 60, 74], "spheric": [1, 53, 59, 60, 63, 72, 88], "spherical_grid": [41, 51, 54, 58], "spherical_relp_model": [53, 59, 60], "spindl": [14, 53, 59, 60, 81, 82, 86, 87], "spinner": 33, "spiral": 78, "spirit": 0, "split": [4, 12, 14, 24, 38, 47, 51, 53, 54, 59, 60, 63, 66, 77, 78, 81, 82, 83, 85, 86, 88, 93, 96], "split_": 83, "split_0": 85, "split_00": 83, "split_1": 85, "split_57": 83, "split_experi": [54, 81, 83, 85, 88, 93], "split_jacobian_into_block": 14, "split_json": 67, "split_matches_into_block": 14, "spot": [4, 11, 16, 35, 41, 42, 44, 45, 47, 49, 50, 51, 53, 54, 58, 59, 60, 64, 67, 77, 79, 81, 83, 85, 93, 96], "spot_count": 49, "spot_count_no_ic": 49, "spot_counts_per_imag": 71, "spot_dens": 47, "spot_find": [19, 32], "spot_predict": [19, 32], "spotdensityfilt": [16, 19], "spotfind": [16, 19, 47, 48, 75, 79, 82, 86, 95, 96], "spotfinderfactori": [16, 19], "spread": [22, 63, 76, 78, 79], "spring": 76, "sqr": 6, "sqrt": [2, 14, 18, 40, 72, 82, 84, 86], "squar": [14, 53, 59, 60, 74, 82, 86, 87], "src": [4, 33], "ssh": 9, "ssrl_p6": 48, "ssx": 89, "ssx_index": 89, "ssx_integr": 89, "stabil": 83, "stabilis": 75, "stabl": [7, 88], "stacei": 74, "stack": 12, "stack_imag": 51, "stack_mod": 51, "staff": 4, "stage": [2, 35, 73, 74, 75, 77, 82, 86, 87, 88], "stai": [14, 76], "stan": 95, "standard": [1, 2, 15, 21, 23, 25, 35, 40, 47, 54, 63, 70, 72, 74, 75, 76, 79, 81, 83, 84, 85, 88, 96], "standard_error": [18, 40, 72], "standardis": 2, "star": [18, 77], "start": [1, 2, 8, 15, 18, 23, 25, 33, 47, 48, 53, 54, 59, 60, 63, 68, 69, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 91, 98], "stat": [48, 63], "state": [2, 14, 53, 59, 60, 82, 86], "static": [11, 12, 14, 16, 17, 18, 21, 22, 23, 24, 25, 26, 28, 29, 31, 41, 44, 51, 53, 54, 57, 58, 59, 60, 62, 73, 74, 81, 82, 83, 87, 88], "static_onli": 23, "staticmethod": 4, "statist": [1, 14, 42, 43, 44, 47, 48, 53, 59, 60, 63, 65, 67, 72, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 96], "statisticalweightingstrategi": [14, 19], "statprim": 18, "statu": [3, 79], "std": [10, 22, 23, 24, 25, 26, 40, 63, 72, 79, 84], "std_string": [23, 24, 25], "stdcutoff": [63, 72], "stddev": [76, 84], "stdin": 52, "steadi": 87, "steep": [43, 86], "stef": 0, "steller": [11, 53], "step": [9, 14, 18, 40, 44, 45, 53, 54, 59, 60, 63, 70, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 97], "step_backward": 14, "step_forward": 14, "step_siz": [11, 53], "step_threshold": 14, "stepanov": 95, "stepwis": 96, "stereograph": [68, 76], "stereographic_project": 71, "stevenson": 95, "stfc": [90, 94], "still": [1, 3, 9, 11, 12, 14, 16, 24, 52, 53, 54, 59, 60, 63, 73, 74, 75, 76, 78, 81, 82, 83, 85, 86, 87, 95, 96], "stills_index": 19, "stills_manag": 14, "stills_process": [16, 96], "stillsindex": 11, "stillsindexerbasisvectorsearch": 11, "stillsindexerknownorient": 11, "stillsindexerlatticesearch": 11, "stillsreflectionmanag": [14, 19], "stillsweightingstrategi": [14, 19], "stop": [11, 15, 41, 47, 49, 51, 54, 58, 63, 69, 72, 74, 75, 82, 84, 86], "storag": 14, "store": [3, 4, 14, 18, 48, 57, 74, 75], "str": [4, 6, 11, 15, 18, 21, 22, 24, 25, 26, 33, 34, 36, 37, 38, 40, 41, 42, 44, 45, 46, 47, 50, 51, 52, 53, 54, 57, 58, 59, 60, 61, 63, 64, 66, 68, 69, 70, 72], "straight": [78, 81, 82, 86, 87], "straightforward": [73, 76, 77, 88], "strain": 95, "strategi": [11, 14, 16, 47, 53, 59, 60, 82, 86, 95], "streamwrapp": 33, "strength": [1, 74, 76, 88, 95], "strict": 92, "strictli": [82, 84, 85, 86], "string": [7, 12, 14, 33, 43, 47, 49, 53, 54, 59, 60, 63, 68, 69, 70, 72], "strong": [1, 3, 16, 44, 47, 49, 51, 53, 54, 62, 64, 67, 70, 73, 74, 75, 76, 77, 78, 81, 82, 83, 85, 86, 87, 88, 96], "strongli": [1, 63, 84], "struct": [3, 75, 95], "structur": [0, 7, 14, 24, 53, 59, 60, 63, 74, 75, 76, 77, 78, 82, 84, 85, 86, 87, 88, 90, 95, 97], "struggl": 73, "stuart": [11, 95, 97], "studi": [0, 95], "stuff": [12, 33], "style": [4, 53, 72], "stype": 23, "sub": [40, 46, 53, 59, 60, 73, 76, 77, 82, 84, 85, 86, 87, 90], "subclass": [4, 14, 15], "subdirectori": [74, 76, 84, 86, 87], "subgroup": 18, "subgroups_t": 18, "subject": 18, "submit": [4, 83, 95], "suboptim": [73, 84], "subprocess": 4, "subsampl": 54, "subsect": 75, "subsequ": [9, 15, 75, 77, 81, 82, 84, 86, 87, 88], "subset": [1, 14, 38, 46, 53, 54, 59, 60, 63, 64, 72, 76, 78, 81, 82, 84, 86, 87], "substanti": 88, "substitut": [7, 92], "substructur": 76, "subtl": 77, "subtli": 35, "subtract": [31, 41, 54, 73, 78, 87], "subtract_background": 41, "succe": 78, "success": [16, 18, 73, 74, 75, 76, 82, 83, 86, 87, 96], "successfulli": [75, 83], "sudo": 91, "suffic": [53, 59, 60], "suffici": [1, 7, 40, 78, 83, 85, 87], "suffix": [33, 40], "suggest": [73, 74, 76, 79, 81, 82, 83, 85, 86, 88], "suit": [7, 44, 48], "suitabl": [1, 15, 44, 53, 59, 60, 63, 72, 74, 75, 82, 85, 86, 87, 88, 96], "sum": [1, 3, 6, 18, 29, 40, 44, 51, 54, 55, 63, 74, 81, 82, 83, 84, 85, 86, 87], "sum_": 55, "summari": [0, 12, 33, 65, 76, 81, 82, 83, 84, 85, 86, 87, 88, 96], "summaris": [3, 74, 96], "summary_t": 18, "summat": [1, 35, 40, 54, 63, 74, 81, 82, 83, 84, 85, 86], "super": 4, "supercel": 81, "superpos": 77, "suppli": [14, 52, 53, 54, 59, 60, 63, 75], "support": [0, 4, 7, 11, 43, 44, 45, 51, 52, 53, 55, 59, 60, 70, 71, 79, 90], "sure": [9, 72, 73, 74, 77, 78, 87], "surfac": [1, 15, 35, 81, 82, 86, 87, 88], "surface_weight": [1, 63], "survei": 97, "suspect": [77, 78], "sutton": [11, 95], "sv_refin": 81, "svn": 9, "sweep": [1, 15, 63, 72, 76, 79, 82, 83, 85, 86, 88, 89, 96], "sweep00": 76, "sweep1": 79, "sweep30": 76, "switch": [7, 18, 76, 81, 83, 85], "sxd": 94, "sy": [4, 83], "sym": 18, "sym_op": 18, "sym_op_scor": 18, "sym_ops_t": 18, "symbol": [2, 12, 53, 84, 85], "symm": [37, 73], "symmetr": [1, 40, 69, 73, 76, 82, 84, 85, 86, 88], "symmetri": [1, 11, 15, 19, 32, 37, 40, 44, 53, 59, 60, 63, 68, 70, 71, 72, 75, 76, 80, 81, 83, 95], "symmetris": 18, "symmetry_bas": [18, 19], "symmetryanalysi": [18, 19], "symmetryhandl": 11, "symop": 78, "symop_threshold": 37, "synaptotagmin": 95, "synch": 84, "synchrotron": [74, 78, 90, 94, 96, 97], "syntax": [1, 74], "synthesi": 83, "synthet": [35, 85], "synuclein": 95, "sys_absent_threshold": 53, "system": [0, 2, 7, 33, 54, 74, 75, 76, 79, 82, 86, 95], "system_phil": 33, "systemat": [1, 40, 68, 69, 72, 77, 78, 79, 81, 82, 84, 86, 87], "systematic_abs": 69, "s\u00fcdhof": 95, "t": [1, 2, 15, 22, 23, 25, 26, 29, 33, 35, 38, 40, 71, 73, 74, 75, 76, 81, 82, 83, 86, 87, 95], "t0": [82, 86], "t1": 78, "ta": 95, "tab": [71, 76, 84, 87], "tabl": [1, 2, 3, 4, 14, 15, 16, 33, 35, 38, 46, 47, 54, 57, 59, 60, 63, 65, 74, 75, 77, 78, 81, 82, 83, 84, 85, 86, 87], "tabul": 35, "tailor": 16, "takanori": 0, "take": [4, 15, 17, 18, 38, 40, 46, 48, 52, 53, 54, 58, 59, 60, 63, 69, 74, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 93, 95], "taken": [1, 35, 53, 57, 59, 60, 62, 75, 76, 82, 83, 84, 86, 87, 88], "tale": 78, "talk": 0, "tandem": 97, "tanh": [43, 72], "tantalis": 97, "tape": 54, "tar": [7, 48, 75, 76, 78, 85, 86, 87, 88, 91], "tara": 0, "target": [1, 11, 14, 15, 18, 19, 53, 59, 60, 63, 70, 73, 74, 81, 82, 84, 86, 87], "target_angl": 11, "target_bravais_str": 11, "target_cycl": 63, "target_model": 63, "target_mtz": 63, "target_space_group": 11, "target_stil": 14, "target_symmetri": 11, "target_symmetry_primit": 11, "target_unit_cel": 11, "targetedoutlierreject": 15, "targetfactori": [14, 19], "tarik": 0, "task": [16, 54, 76, 82, 83, 86, 87], "tasklist": 83, "tasso": 97, "tau": 14, "tau2": 75, "tau3": 75, "tau_2": 75, "tau_3": 75, "tbc": 97, "tc": 95, "tchon": 0, "tcsh": 83, "technic": 97, "techniqu": 97, "technolog": 97, "technologi": 35, "teha": 83, "tell": [74, 77, 81, 83, 87, 93], "tem": 73, "tempel": [77, 78], "temperatur": [83, 95], "templat": [3, 21, 22, 23, 24, 25, 26, 29, 33, 52, 75, 79, 82, 83, 86, 87, 93], "ten": 76, "tend": [74, 75], "tendenc": 75, "term": [1, 2, 14, 53, 59, 60, 63, 73, 82, 86, 87, 88], "termin": [14, 18, 53, 59, 60, 63, 79, 81, 91], "termination_param": 18, "termination_paramet": 18, "terribl": 83, "terwillig": 95, "test": [1, 11, 14, 15, 18, 33, 37, 53, 61, 63, 69, 72, 75, 76, 78, 83, 84, 85, 87, 88], "test_for_termin": 14, "test_miller_set": 18, "test_objective_increasing_but_not_nref": 14, "test_rmsd_converg": 14, "tetragon": [76, 81], "text": [2, 24, 33, 35, 73, 74, 82, 83, 86, 87], "textrm": [76, 81], "tgz": 48, "th_8_2": 81, "th_8_2_": 79, "than": [1, 2, 7, 11, 18, 21, 38, 41, 46, 47, 51, 53, 54, 56, 58, 59, 60, 63, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 93, 96, 97], "thank": [77, 78, 83], "thaum_m10s15_3_": 81, "thaumatin": [79, 81], "thei": [2, 9, 11, 14, 16, 18, 38, 46, 47, 53, 54, 59, 60, 73, 74, 75, 76, 78, 81, 82, 86, 87, 97], "them": [4, 16, 25, 38, 46, 59, 73, 74, 75, 76, 78, 81, 82, 83, 86, 87, 93, 96], "themselv": [1, 23], "theoret": 84, "theori": [77, 92], "therefor": [1, 4, 14, 53, 59, 60, 73, 82, 83, 84, 86, 88], "thereof": 54, "thermofish": 73, "theta": [23, 88], "thi": [0, 1, 2, 3, 4, 6, 7, 9, 11, 14, 15, 16, 18, 21, 23, 24, 25, 29, 33, 34, 35, 36, 37, 38, 40, 41, 42, 43, 44, 46, 47, 48, 50, 51, 52, 53, 54, 55, 56, 58, 59, 60, 61, 63, 66, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 92, 93, 94, 95, 96, 97], "thick": [23, 35, 52, 53, 54, 59, 60, 82, 86], "thin": [1, 18, 72], "thing": [4, 6, 42, 73, 81, 83, 84, 97], "think": [2, 78, 83, 97], "third": [0, 1, 9, 52, 73], "thompson": 0, "thomson": 73, "thorn": 95, "thorough": 77, "those": [0, 7, 9, 14, 33, 40, 49, 53, 59, 60, 66, 70, 73, 74, 76, 77, 82, 83, 84, 86, 87, 88], "though": [7, 73, 74, 76, 81, 82, 83, 84, 86, 88], "thought": [77, 78], "three": [1, 2, 3, 11, 53, 57, 59, 60, 62, 73, 74, 76, 82, 84, 86, 87, 90, 97], "threshold": [1, 15, 16, 31, 37, 38, 40, 41, 44, 45, 47, 51, 54, 58, 69, 70, 72, 73, 74, 75, 78, 82, 84, 86, 87], "threshold_funct": 16, "threshold_prob": [53, 59, 60], "through": [0, 1, 14, 23, 35, 63, 73, 74, 76, 77, 78, 82, 83, 84, 86, 87, 88, 97], "throughout": [2, 81, 84], "throughput": 48, "throw": [38, 47], "thrown": 81, "thu": [74, 82, 83, 86, 87], "thygesen": 74, "ti": 74, "tick": [74, 87], "tie": [53, 59, 60], "tie_to_group": [53, 59, 60], "tie_to_target": [53, 59, 60, 74, 75], "tiff": 45, "tight": 87, "tightli": 95, "tile": [80, 82, 86, 87], "tilt": 73, "time": [2, 4, 16, 24, 26, 33, 46, 63, 73, 75, 76, 77, 81, 82, 83, 84, 85, 86, 87, 94, 95, 97], "timepix": [74, 75], "timer": 33, "timestamp": [52, 96], "tini": [12, 26], "tiny_int_2": 12, "tir": [74, 80], "titl": [33, 73, 84, 85], "tl": 95, "tmp": 79, "tmp4xxusn": 79, "to_cryst": [27, 30], "to_dict": [15, 22, 23, 24, 25], "to_imageset": [27, 30], "to_json_fil": 14, "to_shelx": [73, 88], "to_xd": [27, 30], "todai": 97, "tof": 94, "tofleastsquaresresidualwithrmsdcutoff": [14, 19], "tofreflectionmanag": [14, 19], "tofspotfind": [16, 19], "togeth": [1, 2, 63, 72, 74, 75, 76, 81, 83, 97], "toggl": [4, 76, 82, 86], "token": 23, "toler": [11, 18, 38, 41, 44, 51, 53, 54, 58, 63, 72, 75, 83, 88], "toll": 74, "tom": 97, "too": [14, 40, 53, 59, 60, 74, 78, 81, 82, 83, 84, 86, 87], "took": [79, 81, 83], "tool": [76, 77, 78, 82, 84, 86, 87, 89, 90], "toolbox": [2, 95], "toolkit": [7, 38, 78, 83, 94, 95], "top": [4, 12, 73, 74, 78], "topic": 78, "tort": 92, "total": [11, 14, 47, 49, 74, 76, 79, 81, 82, 83, 84, 86, 87, 88], "total_intens": 49, "total_reflect": [41, 51, 54, 58], "touch": 76, "toward": [1, 73, 74, 81, 97], "toxic": 95, "tp": [79, 85], "traceback": 33, "track": [14, 53, 59, 60, 76, 78, 82, 86, 87], "track_condition_numb": [53, 59, 60], "track_gradi": [53, 59, 60], "track_jacobian_structur": [53, 59, 60], "track_normal_matrix": [53, 59, 60], "track_out_of_sample_rmsd": [53, 59, 60], "track_parameter_correl": [53, 59, 60, 83], "track_step": [53, 59, 60], "trade": [53, 59, 60], "train": [84, 86, 87], "tran": 95, "transduct": 74, "transfer": 0, "transform": [2, 11, 39, 53, 60, 85, 87, 88], "transit": 77, "translat": [30, 53, 59, 60, 77, 82, 84, 86], "transmiss": [21, 52, 82, 86], "treat": [53, 59, 60, 76, 81, 93], "treat_single_image_as_stil": [53, 59, 60], "treatment": 84, "tree": [83, 87], "trek": 97, "tri": [33, 47], "tricki": 76, "triclin": [60, 70, 74, 75, 82, 86, 87, 88], "trigger": [53, 59, 60, 63], "trim": [53, 59, 60, 73], "trim_scan_to_observ": [53, 59, 60], "triplet": 53, "trivial": [4, 78], "trivial_accessor": [10, 12, 25, 26], "troubleshoot": 78, "trough": [86, 87], "trp_ag_": 85, "true": [1, 2, 4, 6, 11, 14, 15, 16, 18, 21, 22, 23, 24, 25, 26, 29, 30, 31, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72, 73, 75, 77, 81, 82, 83, 84, 86, 87, 93], "truncat": [18, 53, 54, 59, 60, 82, 84, 85, 86], "trunccauchy_pdf": [18, 19], "trunk": 9, "trust": [0, 47, 50, 52, 74, 78], "trusted_rang": [3, 23, 52, 82, 86], "trustworthi": [46, 82, 86, 87], "truth": 83, "try": [1, 4, 7, 24, 33, 63, 73, 74, 76, 77, 78, 79, 81, 82, 83, 86, 96], "try_read_experi": 33, "try_read_experiments_from_imag": 33, "try_read_reflect": 33, "trypsin": 85, "tsai": 95, "tukei": [53, 54, 59, 60, 81, 82, 83, 85, 86, 87], "tune": [54, 82, 86, 87], "tuning_const": 54, "tupl": [4, 11, 14, 15, 16, 18, 21, 22, 23, 25, 26, 33, 53, 59, 60, 83], "turn": [1, 2, 11, 25, 53, 54, 59, 60, 63, 73, 76, 78, 81, 82, 83, 86, 87], "tutori": [1, 7, 8, 74, 75, 76, 77, 78, 79, 81, 83, 84, 93], "tutorial_data": [81, 86], "tw": 74, "tweak": 85, "twice": [53, 59, 60, 82, 86, 87], "twin": [18, 61, 76, 79], "twist": 74, "two": [1, 2, 3, 4, 15, 18, 23, 35, 39, 52, 53, 59, 60, 64, 66, 73, 74, 76, 77, 78, 82, 86, 87, 88], "two_theta": [23, 72], "two_theta_angl": 23, "two_theta_direct": 23, "two_theta_refin": [71, 72, 76, 88], "two_theta_refine_2theta": 76, "tyoe": 33, "type": [1, 3, 4, 6, 7, 11, 14, 15, 17, 18, 22, 23, 24, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72, 74, 79, 82, 83, 84, 85, 86, 87, 91], "typic": [1, 2, 7, 11, 35, 47, 48, 53, 54, 59, 60, 63, 66, 69, 72, 74, 78, 81, 82, 86, 87, 88], "u": [2, 4, 35, 73, 74, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 95], "u_0": 2, "u_cif": 84, "ub": [2, 74, 81, 82, 85, 86, 88, 95], "ub_matrix": 3, "uc_abs_angle_toler": 22, "uc_rel_length_toler": 22, "uctbx": [2, 11, 22], "uervirojnangkoorn": 95, "uhlig": 95, "uk": [0, 91, 99], "ultim": 77, "un": 35, "unabl": [82, 86], "uncertainti": [1, 40, 53, 72, 75, 82, 84, 86, 87, 88], "unclear": 2, "uncom": 83, "unconstrain": 88, "unconvent": 77, "uncorrect": [63, 81, 82, 84, 86, 87], "under": [0, 7, 15, 47, 48, 82, 83, 86, 87, 90], "undergon": 77, "underli": 96, "understand": [78, 82, 85, 86, 87, 97], "understood": 87, "underwai": [81, 94], "unequ": [82, 86, 87], "unexpect": 84, "unfeas": 44, "unfortun": [2, 78, 81, 83, 84], "unhandl": [24, 33, 52], "unicod": [2, 75], "uniform": [82, 86, 87], "unindex": [53, 54, 73, 74, 78, 82, 85, 86, 87], "unindexed_reflect": 11, "unintegr": [54, 82, 86], "uniq": [73, 82, 84, 85, 86], "uniqu": [24, 52, 53, 63, 72, 74, 76, 79, 82, 84, 85, 86, 87, 88], "unit": [2, 11, 18, 22, 33, 40, 41, 44, 45, 46, 47, 50, 51, 53, 54, 56, 57, 58, 59, 60, 63, 70, 72, 73, 74, 75, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 92, 96], "unit_cel": [2, 11, 22, 33, 41, 44, 45, 46, 47, 50, 51, 53, 54, 58, 59, 60, 63, 72, 73, 74, 75, 77, 78, 81, 82, 85, 86, 96], "unit_cell_clust": [40, 72], "unit_s0": 21, "uniti": [63, 78], "univers": [2, 11], "unknown": [2, 26, 44], "unless": [1, 7, 21, 33, 53, 59, 60, 63, 72, 74], "unlik": 88, "unmerg": [1, 43, 44, 72, 73, 74, 79, 83, 84, 87, 98], "unmerged_mtz": [1, 63], "unpack": [7, 75], "unphys": [41, 51, 54, 58, 82, 86], "unpolar": 21, "unrealist": 53, "unreason": 74, "unrecognis": 78, "unrel": [82, 86], "unscal": [15, 44, 75, 78, 82, 86, 87], "unsign": [10, 12, 14, 24, 25, 26], "unstabl": [1, 63], "unsuccess": 83, "untick": 87, "until": [11, 14, 53, 59, 60, 73, 77, 78, 81, 82, 86, 87], "untrust": [47, 50, 51, 73, 75], "unus": 59, "unusu": [75, 83], "unwant": 50, "unwarp": 78, "unweight": 14, "unwieldi": 83, "up": [1, 7, 11, 14, 15, 24, 40, 42, 53, 54, 59, 60, 66, 68, 73, 74, 75, 77, 81, 82, 83, 84, 86, 87, 91, 96, 97], "updat": [9, 14, 15, 33, 44, 53, 59, 63, 81, 82, 83, 85, 86, 87, 98], "update_analysi": 11, "update_detector_px_mm_data": 26, "update_journ": 14, "update_match": 14, "update_residu": 14, "upon": [15, 76], "upper": [18, 54, 63, 72, 87], "upper_bound": 18, "uptick": 73, "us": [0, 2, 3, 4, 7, 9, 11, 12, 14, 15, 16, 18, 21, 22, 23, 24, 25, 26, 29, 33, 34, 35, 37, 38, 40, 41, 42, 44, 45, 46, 47, 48, 50, 51, 52, 53, 54, 55, 58, 59, 60, 61, 62, 63, 64, 66, 69, 70, 71, 73, 74, 75, 76, 77, 78, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97], "usa": [0, 2, 35], "usag": [6, 7, 63, 72, 83, 88], "use_al": [1, 63, 72], "use_all_reflect": 81, "use_beam_refer": 52, "use_curvatur": [18, 40, 72], "use_dataman_shel": 72, "use_dataset": 63, "use_detector_refer": 52, "use_dynamic_mask": 54, "use_free_set": 63, "use_gonio_refer": 52, "use_internal_vari": 63, "use_lattice_symmetri": 72, "use_p1_indices_as_se": 53, "use_starting_angl": 68, "used_in_index": 4, "used_in_refin": [14, 46], "useless": [78, 83], "user": [2, 4, 7, 11, 14, 36, 46, 47, 48, 54, 63, 78, 79, 80, 82, 83, 84, 86, 87, 90, 91], "usernam": 9, "usr": [7, 91], "usual": [2, 14, 41, 42, 47, 72, 73, 74, 78, 79, 81, 82, 83, 86, 87, 88, 93], "util": [6, 12, 14, 32, 35, 38, 48, 71, 83], "utilis": 97, "uuid": 52, "v": [1, 2, 7, 43, 53, 59, 60, 72, 73, 80, 82, 86, 87, 95, 96, 97], "v5": 44, "v5_next": 44, "vajjhala": 74, "valid": [12, 14, 15, 26, 33, 48, 49, 53, 54, 59, 60, 63, 84, 85], "valid_foreground_threshold": [12, 54], "valu": [1, 3, 7, 10, 11, 14, 15, 18, 33, 35, 40, 41, 42, 43, 44, 46, 47, 48, 51, 52, 53, 54, 55, 57, 58, 59, 60, 63, 65, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 96], "valuabl": 73, "value_max": [15, 40, 43, 44, 45, 46, 47, 52, 53, 54, 59, 60, 63, 69, 72], "value_min": [15, 38, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 58, 59, 60, 62, 63, 64, 67, 68, 69, 70, 72], "valueerror": [15, 33], "van": [53, 59, 60, 95], "var": 14, "vari": [1, 14, 17, 41, 44, 51, 53, 54, 57, 58, 59, 60, 73, 74, 81, 82, 83, 85, 86, 87, 88, 93], "variabl": [2, 52, 63, 74, 75, 81, 87], "varianc": [1, 3, 14, 15, 40, 45, 47, 51, 54, 63, 72, 76, 82, 84, 86, 87], "variat": [73, 82, 83, 84, 86, 87, 88], "varieti": 84, "variou": [1, 2, 11, 14, 43, 44, 52, 53, 60, 62, 63, 72, 74, 75, 82, 86, 87, 91, 94], "ve": [22, 74, 76], "vec": 2, "vec2": 23, "vec3": [22, 23, 25], "vec3_doubl": [4, 11, 25], "vector": [1, 2, 3, 6, 11, 14, 18, 21, 23, 34, 35, 40, 52, 53, 77, 82, 83, 84, 86, 87], "vectori": 2, "vendor": 26, "venugopalan": 95, "verbos": [33, 48, 53, 59, 60, 82, 86, 96], "veri": [1, 35, 73, 74, 76, 78, 81, 82, 83, 84, 86, 87, 88], "verifi": [6, 24], "versa": 14, "version": [7, 14, 35, 44, 48, 49, 75, 79, 81, 84, 87], "versu": [77, 82, 86, 87], "vertic": [2, 54, 78], "via": [0, 2, 4, 9, 45, 55, 76, 87, 88, 90], "view": [4, 40, 47, 51, 74, 75, 77, 78, 82, 86, 87, 88, 95, 97], "viewer": [2, 73, 74, 75, 77, 78, 81, 82, 86, 87, 88], "viewhkl": 73, "vinetski": 95, "virtual": 44, "virtual_fram": 44, "visibl": [76, 82, 86, 87], "visit": 48, "viz": [53, 59, 60, 88], "vk": 95, "vmxi": 84, "vmxi_proteinase_k_sweep": 84, "void": [10, 12, 14, 22, 23, 24, 25, 26], "vollmar": 95, "volum": [11, 41, 43, 51, 53, 54, 58, 59, 60, 72, 73, 74, 76, 77, 78, 82, 83, 84, 85, 86, 87, 88, 97], "volume_cutoff": [11, 53], "volume_weight": [11, 53], "vondelft": 97, "voxel": 53, "voxel_grid_point": 53, "vv": 96, "w": [0, 2, 11, 14, 15, 95], "w_": 18, "wa": [2, 7, 14, 15, 47, 53, 59, 60, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88], "wagner": 95, "wai": [2, 33, 73, 74, 77, 78, 79, 81, 82, 83, 84, 92, 93, 94, 96], "wait": 73, "wakatsuki": 95, "wall": 95, "walsh": 95, "wander": 74, "wang": 73, "want": [1, 48, 73, 74, 77, 78, 81, 82, 83, 84, 86, 87, 88], "ward": 53, "warn": [77, 78, 83, 84, 86], "warn_if_setting_unused_refinement_protocol_param": 11, "warrant": 84, "warranti": 92, "wast": 97, "water": 95, "waterman": [0, 11, 73, 75, 95, 97, 98], "wave": 11, "wavelength": [3, 6, 14, 18, 21, 22, 33, 38, 44, 52, 53, 59, 60, 63, 72, 73, 74, 75, 79, 82, 84, 85, 86, 88], "wavelength_rang": [21, 52], "wavelength_spread": [41, 51, 54, 58], "wavelength_toler": [24, 33, 44, 72], "wavelength_weight": [14, 53, 59, 60], "wavelengthgroup": [32, 33], "we": [0, 2, 4, 7, 11, 14, 16, 21, 25, 26, 33, 35, 37, 73, 74, 75, 76, 77, 78, 79, 81, 82, 83, 84, 85, 86, 87, 88, 90, 91, 93, 94, 95, 96, 97], "weak": [1, 75, 77, 78, 79, 84, 96], "weaker": [73, 77], "weakli": [63, 81], "weatherbi": 95, "web": [48, 71, 73], "webber": 0, "webpag": 48, "webserv": 48, "wedg": [1, 11, 53, 80, 83, 87], "weekend": 0, "wei": 95, "weight": [10, 11, 14, 15, 18, 40, 53, 59, 60, 63, 72, 81, 82, 83, 86], "weighted_mean": 33, "weighting_schem": 63, "weighting_strategi": [14, 53, 59, 60], "weighting_strategy_overrid": 14, "welcom": [0, 83], "well": [11, 29, 44, 57, 62, 72, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 87], "wellcom": [0, 90], "weng": 95, "were": [4, 11, 14, 38, 48, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88], "wernet": 95, "west": [90, 99], "westbrook": 2, "wget": [9, 48, 91], "what": [2, 14, 23, 72, 74, 76, 77, 78, 82, 85, 86, 87, 97], "whatev": [78, 82, 83, 86, 87], "wheel": 0, "when": [1, 2, 9, 11, 14, 15, 18, 25, 26, 33, 35, 38, 44, 47, 50, 51, 52, 53, 54, 59, 60, 63, 66, 69, 70, 72, 73, 75, 76, 77, 78, 79, 82, 83, 84, 86, 87, 93, 96], "whenev": 4, "where": [1, 2, 4, 7, 11, 14, 15, 18, 21, 23, 24, 25, 26, 29, 35, 38, 40, 43, 44, 47, 49, 52, 53, 54, 55, 59, 60, 63, 66, 69, 72, 74, 76, 77, 78, 81, 82, 83, 84, 86, 87, 88, 91], "wherea": [47, 63, 74, 81, 82, 86, 87], "whether": [1, 4, 14, 15, 18, 33, 38, 47, 51, 53, 54, 57, 59, 60, 62, 63, 65, 69, 72, 82, 83, 86, 87, 92], "which": [0, 1, 2, 4, 7, 11, 14, 15, 18, 21, 22, 23, 25, 29, 33, 35, 37, 38, 40, 42, 43, 44, 46, 47, 48, 50, 51, 52, 53, 54, 57, 59, 60, 61, 62, 63, 65, 70, 72, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88, 91, 93, 96], "while": [1, 2, 9, 14, 38, 53, 66, 74, 75, 81, 82, 83, 84, 86, 87, 88], "whilst": [2, 3, 53, 59, 60, 83], "white": [94, 95, 97], "whitelegg": 95, "who": [0, 7], "whole": [1, 4, 47, 50, 51, 53, 59, 60, 63, 72, 76, 78, 81, 82, 83, 86, 87], "whose": [2, 47, 50, 51, 53, 54, 59, 60], "why": [82, 86, 97], "wi": 95, "wide": [1, 7, 47, 51, 53, 64, 74, 76, 84], "wide_search_bin": [53, 64], "wider": [53, 59, 60], "width": [12, 14, 15, 18, 38, 46, 47, 50, 51, 53, 59, 60, 66, 75, 81, 82, 86, 87], "wiki": [7, 9, 18], "wikipedia": 18, "wildcard": 87, "william": [0, 95], "wilson": [40, 73, 79, 82, 84, 86], "window": [7, 73, 75, 78, 87, 91], "winn": 79, "winter": [0, 11, 18, 40, 79, 84, 95, 97, 98], "wish": [0, 88], "within": [0, 1, 2, 4, 7, 14, 37, 47, 50, 51, 52, 53, 58, 59, 60, 63, 66, 72, 74, 79, 81, 82, 83, 84, 86, 87, 88, 90, 97], "within_spot_sigma": 54, "without": [3, 7, 33, 76, 78, 81, 83, 87, 88, 92, 93], "wj": 73, "wl": 33, "wojdyr": 0, "wolfgang": 97, "wolfram": [77, 78], "won": [74, 76, 81], "word": 78, "work": [0, 2, 4, 7, 9, 11, 14, 21, 25, 33, 53, 54, 59, 60, 63, 73, 74, 76, 77, 78, 79, 81, 83, 84, 86, 87, 88, 90, 93, 94, 97], "workaround": 81, "workshop": [0, 11, 86, 87], "worri": [78, 81, 87], "worrisom": 84, "wors": [77, 81, 82, 83, 84, 86, 87], "worsen": 86, "worst": 45, "worth": [76, 78, 82, 83, 84, 85, 86, 87], "would": [1, 7, 15, 53, 59, 60, 73, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 93, 97], "wp6": 97, "wrap": [29, 96, 97], "wrapper": 18, "write": [3, 7, 33, 40, 44, 46, 47, 53, 59, 60, 70, 74, 77, 78, 81, 82, 83, 84, 85, 86, 87, 96], "write_column": [32, 33], "write_hot_mask": [16, 47], "write_hot_pixel_mask": 16, "writer": 33, "written": [0, 2, 7, 44, 45, 52, 74, 82, 83, 85, 86, 92], "wrong": [14, 74, 78, 81, 82, 86], "wrongli": 78, "wrt": 2, "www": [18, 48], "wx": 14, "wxtbx": 33, "wy": 14, "wz": 14, "x": [1, 2, 11, 14, 18, 21, 22, 23, 25, 33, 35, 40, 43, 47, 50, 51, 52, 53, 59, 60, 61, 63, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 87, 90, 91, 94, 95, 97], "x0": [47, 50, 51], "x0692": 82, "x0692_1_": 82, "x0692_1_0": 82, "x1": [47, 50, 51], "x212b": [2, 75], "x247398": 78, "x86_64": [7, 91], "xaamdi": 35, "xc": [47, 50, 51, 81, 82, 83, 86], "xchem": 82, "xd": [0, 22, 24, 30, 44, 53, 78, 81, 82, 86, 87, 97], "xdg": 74, "xds_ascii": [30, 44], "xds_detector_nam": [27, 30], "xds_inp": [24, 30], "xds_other": 24, "xfel": 90, "xia": 76, "xia2": [30, 71, 73, 80, 82, 86, 88, 95], "xjf": [7, 91], "xml": [49, 54], "xo": [81, 82, 83, 86], "xparm": [30, 33, 44], "xparm_xd": 30, "xprep": [70, 73, 88], "xrai": 21, "xscale": [1, 44], "xta": 83, "xta30_1_": 83, "xta31_1_": 83, "xtal": [44, 63, 83, 84, 85], "xtal7_1_": 83, "xtal8_1_": 83, "xtal_height_above_kapton_mm": 54, "xu": 74, "xvf": 78, "xy": [82, 86], "xycorr": 30, "xyz": 18, "xyzcal": 3, "xyzob": [3, 14], "xz": [7, 44, 76, 91], "xzf": 91, "y": [1, 2, 11, 14, 18, 21, 22, 23, 25, 40, 43, 47, 50, 51, 52, 53, 59, 60, 61, 63, 73, 74, 75, 76, 78, 81, 82, 83, 84, 86, 87, 95], "y0": [47, 50, 51], "y1": [47, 50, 51], "yachandra": 95, "yano": 95, "yc": [47, 50, 51, 81, 82, 83, 86], "yd": 22, "year": [90, 97], "yellow": 73, "yet": [81, 82, 83, 86, 87], "yield": 88, "yilmaz": 83, "yo": [81, 82, 83, 86], "yoon": 74, "you": [1, 4, 7, 9, 23, 40, 48, 54, 71, 72, 73, 74, 76, 77, 78, 79, 81, 82, 83, 84, 86, 87, 88, 91, 97], "young": [0, 95], "your": [4, 7, 9, 35, 48, 73, 76, 77, 79, 82, 83, 84, 86, 87, 88, 93], "yourself": 76, "z": [14, 18, 21, 22, 23, 25, 33, 40, 43, 61, 63, 73, 76, 78, 82, 84, 86, 87, 90], "z_cc": 18, "z_cc_against": 18, "z_cc_for": 18, "z_cc_net": 18, "z_score": 84, "zadvornyi": 95, "zatsepin": 74, "zcc": [18, 40, 73, 76, 82, 84, 85, 86, 87], "zeldin": [0, 95], "zenodo": [82, 88], "zero": [1, 2, 11, 35, 47, 53, 54, 59, 60, 63, 66, 69, 70, 73, 81], "zerr": 73, "zeta": [41, 51, 54, 58, 82, 86, 87], "zhang": 95, "zhao": [74, 95], "zhou": 95, "zhu": 95, "zinger": [73, 83], "zlib": 45, "zmax": 15, "zone": [11, 58, 74], "zoo": 76, "zoom": [73, 74, 76, 77, 82, 86], "zou": 74, "zouni": 95, "zwart": 95, "\u00b2": [82, 84, 86], "\u00b5m": 74, "\u00e5": [6, 21, 73, 74, 76, 82, 84, 86, 87, 95], "\u00e5ngstr\u00f6m": 74, "\u03b1": [74, 95], "\u03b2": [40, 72, 74], "\u03b3": 74, "\u03b4": [40, 72, 87], "\u03b4cc\u00bd": [63, 72, 74, 76, 84], "\u03b4f": 84, "\u03ba": 2, "\u03c3": [40, 72, 82, 84, 86], "\u03c3\u00b2": [82, 84, 86], "\u03c6": [2, 82, 86, 87], "\u03c9": 2, "\u2460": [82, 86], "\u2461": [82, 86], "\u2462": [82, 86], "\ud835\udfd9": 2}, "titles": ["About", "User guide for scaling data with DIALS", "Conventions", "Data files", "Extending DIALS", "Developer Examples", "Reading experiment and data", "Getting started", "Documentation", "Installation for Developers", "dials.algorithms.background", "dials.algorithms.indexing", "dials.algorithms.integration", "dials.algorithms.profile_model", "dials.algorithms.refinement", "dials.algorithms.scaling", "dials.algorithms.spot_finding", "dials.algorithms.spot_prediction", "dials.algorithms.symmetry", "Algorithms", "Array Family", "dxtbx.model.beam", "dxtbx.model.crystal", "dxtbx.model.detector", "dxtbx.model.experiment_list", "dxtbx.model.goniometer", "dxtbx.imageset", "dxtbx", "dxtbx.model.profile", "dxtbx.model.scan", "dxtbx.serialize", "Extensions", "Library Reference", "Util", "dials.align_crystal", "dials.anvil_correction", "dials.apply_mask", "dials.check_indexing_symmetry", "dials.combine_experiments", "dials.compare_orientation_matrices", "dials.cosym", "dials.create_profile_model", "dials.estimate_gain", "dials.estimate_resolution", "dials.export", "dials.export_bitmaps", "dials.filter_reflections", "dials.find_spots", "distl/dials apache server", "dials.find_spots_server/client", "dials.generate_mask", "dials.image_viewer", "dials.import", "dials.index", "dials.integrate", "dials.merge_cbf", "dials.missing_reflections", "dials.plot_scan_varying_model", "dials.predict", "dials.refine", "dials.refine_bravais_settings", "dials.reindex", "dials.report", "dials.scale", "dials.search_beam_position", "dials.show", "dials.slice_sequence", "dials.spot_counts_per_image", "dials.stereographic_projection", "dials.symmetry", "dials.two_theta_refine", "Program documentation", "xia2.multiplex", "Processing Small Molecule MicroED/3DED: Biotin", "MyD88TIR small wedges", "Lysozyme nanocrystals", "Multi-crystal analysis with DIALS and xia2.multiplex", "DPF3 Part 2: A question of centring", "DPF3 Part 1: Correcting poor initial geometry", "Using DIALS at Diamond Light Source", "Tutorials", "Refining multi-tile detector metrology with DIALS", "SARS-CoV-2 main protease (Mpro)", "Multi-crystal analysis with DIALS and BLEND: individual vs joint refinement", "Multi-crystal symmetry analysis and scaling with DIALS", "Multi-lattice Tutorial", "Processing in Detail", "Processing in Detail with DUI", "Small-molecule data reduction tutorial", "DIALS How-To guides", "DIALS: Diffraction Integration for Advanced Light Sources", "Installation", "DIALS License", "Processing Sequences with Missing Images", "Projects", "Publications", "SSX processing guide", "DIALS 1: 12th-13th June 2012 (Diamond Light Source, UK)", "DIALS-3: 22nd May 2013 (Cambridge, UK)", "Workshops"], "titleterms": {"0": [76, 91], "1": [75, 78, 97], "10": 76, "12th": 97, "13th": 97, "18": [], "19": 76, "2": [75, 77, 82], "20": [76, 91], "2012": 97, "2013": 98, "22nd": 98, "29": 76, "3": [75, 91, 98], "3ded": 73, "4": 75, "5": 75, "6": 75, "7": 75, "9": 76, "A": 77, "No": 9, "The": 2, "To": 89, "about": [0, 73], "acknowledg": [0, 77, 78, 81, 83], "ad": 4, "advanc": [1, 90], "against": 1, "algorithm": [10, 11, 12, 13, 14, 15, 16, 17, 18, 19], "align_cryst": 34, "almost": 84, "altern": 88, "analysi": [74, 76, 82, 83, 84, 86], "anvil_correct": 35, "apach": 48, "appli": 81, "applic": 95, "apply_mask": 36, "arrai": 20, "articl": 95, "attende": 98, "axi": 74, "background": 10, "bad": 73, "basi": 4, "basic": [34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "basis_vector_search": 11, "beam": [21, 73, 78], "better": 78, "binari": 91, "biotin": 73, "blend": 83, "bookkeep": 76, "bravai": [73, 82, 86, 87, 88], "build": [48, 91], "built": 7, "cambridg": 98, "case": [43, 72], "cc": 76, "cell": [76, 88], "center": 73, "centr": [73, 77, 78], "check": [78, 87], "check_indexing_symmetri": 37, "choos": 1, "class": 4, "client": 49, "cluster": 76, "collect": 73, "combine_experi": 38, "committe": 97, "common": 1, "compare_orientation_matric": 39, "comparison": 76, "conclus": [77, 78], "contact": 90, "content": [4, 20, 31], "control": 1, "convent": 2, "convert": 77, "coordin": 2, "correct": [73, 78, 81], "cosym": [18, 40], "cov": 82, "create_profile_model": 41, "crystal": [22, 76, 83, 84], "crystallographi": 95, "current": 9, "data": [1, 3, 6, 9, 73, 74, 75, 76, 82, 86, 87, 88, 96], "dataset": [1, 73, 75, 83], "defin": 4, "definit": [34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "delta": 76, "detail": [35, 86, 87], "detector": [23, 74, 81], "determin": [73, 74, 88], "develop": [0, 5, 9, 91], "dial": [0, 1, 4, 7, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 76, 79, 81, 83, 84, 89, 90, 91, 92, 94, 95, 96, 97, 98], "diamond": [79, 97], "diffract": [90, 94], "diffractomet": 2, "discov": 78, "distanc": 74, "distl": 48, "do": [81, 83], "document": [8, 71], "download": 9, "dpf3": [77, 78], "dui": 87, "dxtbx": [2, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30], "east": 0, "entri": 4, "environ": [7, 9], "equat": 2, "estimate_gain": 42, "estimate_resolut": 43, "exampl": [5, 40, 43, 72], "exclud": 73, "experi": [3, 6, 76], "experiment": 78, "experiment_list": 24, "explor": 76, "exploratori": 74, "export": [44, 73, 82, 86, 87, 88, 93], "export_bitmap": 45, "extend": 4, "extens": 31, "famili": 20, "feedback": 79, "file": 3, "filter_reflect": 46, "find": [73, 74, 75, 78, 82, 86, 87, 88], "find_spot": 47, "find_spots_serv": 49, "format": 4, "frame": [2, 73], "full": [34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "fund": 90, "further": 74, "gener": [73, 79], "generate_mask": 50, "geometri": [73, 78], "get": 7, "gltbx_gl_ext": 9, "goniomet": [2, 25], "graphic": 91, "guid": [1, 89, 96], "half": 76, "help": 7, "how": 89, "html": [82, 86], "imag": [73, 93], "image_view": 51, "imageset": 26, "import": [52, 73, 75, 78, 82, 85, 86, 87, 88, 93], "index": [4, 11, 53, 73, 74, 75, 78, 82, 85, 86, 87, 88, 96], "individu": 83, "initi": 78, "inspect": 87, "instal": [7, 9, 91], "instruct": 48, "integr": [12, 54, 73, 74, 75, 82, 85, 86, 87, 88, 90, 96], "intens": 76, "introduct": [34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72, 74, 75, 76, 77, 78, 81, 82, 83, 84, 85, 86, 87, 88], "joint": 83, "jointli": 83, "journal": 95, "june": 97, "keep": 9, "laboratori": 2, "larg": 1, "lattic": [4, 73, 74, 77, 82, 85, 86, 87, 88], "lattice_search": 11, "librari": 32, "licens": 92, "light": [79, 90, 97], "linux": [9, 91], "list": 3, "lysozym": 75, "mac": [9, 91], "mai": 98, "main": 82, "manual": 84, "mask": 73, "matrix": 2, "max_cel": 11, "merg": [75, 82, 85, 86], "merge_cbf": 55, "method": 4, "metrologi": 81, "micro": 73, "minimis": 1, "miss": 93, "missing_reflect": 56, "model": [1, 2, 4, 15, 21, 22, 23, 24, 25, 28, 29, 75, 78], "model_evalu": 11, "modul": 9, "modulenotfounderror": 9, "molecul": [73, 88], "mpro": 82, "mtz": [82, 86, 87], "multi": [73, 76, 81, 83, 84, 85], "multiplex": [72, 76, 84], "myd88tir": 74, "name": 9, "nanocryst": 75, "neutron": 94, "new": 4, "newslett": 95, "next": [7, 81, 83], "note": 73, "offset": 73, "option": [1, 73], "organis": 97, "orient": [2, 74, 76], "orthogonalis": 2, "other": 73, "outlier_reject": 15, "output": 88, "paramet": [7, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 72], "part": [77, 78], "path": 88, "pedest": 73, "plot_scan_varying_model": 57, "point": 4, "poor": 78, "post": 76, "practic": 1, "predict": 58, "preferenti": 76, "prepar": 81, "present": [97, 98], "process": [73, 74, 76, 83, 86, 87, 93, 96], "profil": [4, 28], "profile_model": 13, "program": [71, 97, 98], "project": 94, "proteas": 82, "pseudocentr": 77, "public": 95, "question": 77, "re": 73, "read": 6, "reciproc": 76, "reduct": 88, "refer": [1, 32], "refin": [14, 59, 73, 74, 75, 81, 82, 83, 85, 86, 87, 88, 93], "refine_bravais_set": 60, "reflect": [1, 3], "regress": 9, "reindex": 61, "releas": 91, "report": [62, 82, 86, 95], "reprocess": 84, "result": 87, "sadab": 88, "sar": 82, "scale": [1, 4, 15, 63, 73, 74, 75, 82, 84, 85, 86, 87, 88], "scan": [29, 75], "script": 74, "search": 4, "search_beam_posit": 64, "sequenc": 93, "serial": 30, "server": 48, "set": [9, 76], "show": 65, "slice_sequ": 66, "small": [73, 74, 88], "solv": 73, "sourc": [7, 79, 90, 97], "space": 76, "spot": [73, 74, 75, 78, 82, 86, 87, 88], "spot_counts_per_imag": 67, "spot_find": 16, "spot_predict": 17, "spotfind": 85, "ssx": 96, "ssx_index": 96, "ssx_integr": 96, "stabl": 91, "start": 7, "static": [4, 75], "step": 7, "stereographic_project": 68, "stills_index": 11, "strategi": 4, "structur": 73, "summari": 2, "symmetri": [18, 69, 73, 74, 77, 78, 82, 84, 85, 86, 87, 88], "synchrotron": 95, "tabl": [20, 31], "team": 0, "test": [9, 48], "tile": 81, "tilt": 74, "togeth": 73, "tutori": [80, 82, 85, 86, 87, 88], "two_theta_refin": 70, "uk": [97, 98], "understand": 4, "unit": [76, 88], "unmerg": [82, 86], "up": 9, "us": [1, 43, 72, 79], "user": 1, "util": 33, "v": 83, "vari": 75, "vector": 4, "video": 73, "wedg": 74, "west": 0, "what": [81, 83], "workshop": 99, "write": 4, "xfel": 95, "xia2": [72, 76, 79, 84]}}) \ No newline at end of file