|
| Schema (const Teuchos::RCP< Teuchos::ParameterList > &correlation_params=Teuchos::null) |
| do nothing constructor
|
|
| Schema (const Teuchos::RCP< Teuchos::ParameterList > &input_params, const Teuchos::RCP< Teuchos::ParameterList > &correlation_params) |
| Constructor that takes a parameter list. More...
|
|
| Schema (const std::string &input_file_name, const std::string ¶ms_file_name) |
| Constructor that takes string name of a parameter list file. More...
|
|
| Schema (const Teuchos::RCP< Teuchos::ParameterList > &input_params, const Teuchos::RCP< Teuchos::ParameterList > &correlation_params, const Teuchos::RCP< Schema > &schema) |
| Constructor that takes a parameter list. More...
|
|
| Schema (const int_t roi_width, const int_t roi_height, const int_t step_size_x, const int_t step_size_y, const int_t subset_size, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
| Constructor that takes a parameter list and equally spaced subsets. More...
|
|
| Schema (Teuchos::ArrayRCP< scalar_t > coords_x, Teuchos::ArrayRCP< scalar_t > coords_y, const int_t subset_size, Teuchos::RCP< std::map< int_t, Conformal_Area_Def > > conformal_subset_defs=Teuchos::null, Teuchos::RCP< std::vector< int_t > > neighbor_ids=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
| Constructor that takes a set of coordinates for the subsets and conformal definitions. More...
|
|
void | set_params (const Teuchos::RCP< Teuchos::ParameterList > ¶ms) |
|
void | set_params (const std::string ¶ms_file_name) |
| sets a schema's parameters with the name of a parameters xml file More...
|
|
void | update_extents (const bool use_transformation_augmentation=false) |
| set the extents of the image to be used when only reading a portion of the image More...
|
|
bool | has_extents () const |
| returns true if image extents are being used
|
|
std::vector< int_t > | ref_extents () const |
| returns the local reference extents of the schema on this processor (defines how much of an image is actually used)
|
|
std::vector< int_t > | def_extents () const |
| returns the local deformed extents of the schema on this processor (defines how much of an image is actually used)
|
|
void | set_def_image (const std::string &defName) |
| Replace the deformed image for this Schema.
|
|
void | set_def_image (const int_t img_width, const int_t img_height, const Teuchos::ArrayRCP< intensity_t > defRCP, const int_t id=0) |
| Replace the deformed image using an intensity array.
|
|
void | set_def_image (Teuchos::RCP< Image > img, const int_t id=0) |
| Replace the deformed image using an image.
|
|
void | set_prev_image (Teuchos::RCP< Image > img, const int_t id=0) |
| Replace the previous image using an image.
|
|
void | rotate_def_image () |
| Rotate the deformed image if requested.
|
|
void | set_ref_image (const std::string &refName) |
| Replace the deformed image for this Schema.
|
|
void | set_ref_image (const int_t img_width, const int_t img_height, const Teuchos::ArrayRCP< intensity_t > refRCP) |
| Replace the deformed image using an intensity array.
|
|
void | set_ref_image (Teuchos::RCP< Image > img) |
| Replace the reference image using an image.
|
|
int_t | execute_correlation () |
|
int_t | execute_cross_correlation () |
|
void | project_right_image_into_left_frame (Teuchos::RCP< Triangulation > tri, const bool reference) |
|
void | execute_post_processors () |
| Run the post processors.
|
|
int_t | initialize_cross_correlation (Teuchos::RCP< Triangulation > tri, const Teuchos::RCP< Teuchos::ParameterList > &input_params) |
|
void | save_cross_correlation_fields () |
| Save off the q and r fields once the mapping from left to right image is known.
|
|
int_t | execute_triangulation (Teuchos::RCP< Triangulation > tri, Teuchos::RCP< Schema > right_schema) |
|
int_t | execute_triangulation (Teuchos::RCP< Triangulation > tri) |
|
void | post_execution_tasks () |
| do clean up tasks
|
|
int_t | is_initialized () const |
| Returns if the field storage is initilaized.
|
|
Teuchos::RCP< Image > | ref_img () const |
| Returns a pointer to the reference DICe::Image.
|
|
Teuchos::RCP< Image > | def_img (const int_t index=0) const |
| Returns a pointer to the deformed DICe::Image.
|
|
const std::vector< Teuchos::RCP< Image > > * | def_imgs () const |
| return a pointer to the def images vector
|
|
Teuchos::RCP< Image > | prev_img (const int_t index=0) const |
| Returns a pointer to the preivous DICe::Image.
|
|
const std::vector< Teuchos::RCP< Image > > * | prev_imgs () const |
| return a pointer to the def images vector
|
|
int_t | max_solver_iterations_fast () const |
| Returns the max solver iterations allowed for the fast (gradient based) algorithm.
|
|
int_t | max_solver_iterations_robust () const |
| Returns the max solver iterations allowed for the robust (simplex) algorithm.
|
|
double | robust_solver_tolerance () const |
| Returns the robust solver convergence tolerance.
|
|
double | skip_solve_gamma_threshold () const |
| Returns the threshold for gamma where the solve will be skipped if gamma < threshold.
|
|
double | fast_solver_tolerance () const |
| Returns the fast solver convergence tolerance.
|
|
double | robust_delta_disp () const |
| Returns the variation applied to the displacement initial guess in the simplex method.
|
|
double | robust_delta_theta () const |
| Returns the variation applied to the rotation initial guess in the simplex method.
|
|
int_t | img_width () const |
| Returns the reference and deformed image width.
|
|
int_t | img_height () const |
| Returns the reference and deformed image height.
|
|
int_t | strain_window_size (const int_t post_processor_index) const |
|
int_t | subset_dim () const |
|
void | set_subset_dim (const int_t subset_dim) |
| Sets the size of square subsets (not used for conformal) More...
|
|
int_t | step_size_x () const |
|
void | set_step_size (const int_t step_size_x, const int_t step_size_y) |
| Sets the step sizes for this schema. More...
|
|
void | set_step_size (const int_t step_size) |
| Sets the step sizes for this schema. More...
|
|
int_t | step_size_y () const |
|
int_t | global_num_subsets () const |
| Returns the global number of correlation points.
|
|
int_t | local_num_subsets () const |
| Returns the local number of correlation points.
|
|
Analysis_Type | analysis_type () const |
| Returns true if the analysis is global DIC.
|
|
mv_scalar_type & | global_field_value (const int_t global_id, const DICe::field_enums::Field_Spec spec) |
| Return the value of the given field at the given global id (must be local to this process) More...
|
|
mv_scalar_type & | local_field_value (const int_t local_id, const DICe::field_enums::Field_Spec spec) |
| Return the value of the given field at the given local id (must be local to this process) More...
|
|
void | save_off_fields (const int_t global_id) |
| Save off the current solution into the storage for frame n - 1 (only used if projection_method is VELOCITY_BASED) More...
|
|
void | print_fields (const std::string &fileName="") |
| Print the field values to screen or to a file. More...
|
|
Teuchos::RCP< std::map< int_t, Conformal_Area_Def > > | conformal_subset_defs () |
| Returns a pointer to the Conformal_Subset_Def vector.
|
|
Correlation_Routine | correlation_routine () const |
| Returns the correlation routine (see DICe_Types.h for valid values)
|
|
Interpolation_Method | interpolation_method () const |
| Returns the interpolation method (see DICe_Types.h for valid values)
|
|
Gradient_Method | gradient_method () const |
| Returns the interpolation method (see DICe_Types.h for valid values)
|
|
Optimization_Method | optimization_method () const |
| Returns the optimization method (see DICe_Types.h for valid values)
|
|
Initialization_Method | initialization_method () const |
| Returns the initilaization method (see DICe_Types.h for valid values)
|
|
Projection_Method | projection_method () const |
| Returns the projection method (see DICe_Types.h for valid values)
|
|
void | prepare_optimization_initializers () |
| set up the initializers
|
|
Status_Flag | initial_guess (const int_t subset_gid, Teuchos::RCP< Local_Shape_Function > shape_function) |
|
void | write_control_points_image (const std::string &fileName, const bool use_def_image=false, const bool use_one_point=false) |
| Create an image that shows the correlation points. More...
|
|
void | write_output (const std::string &output_folder, const std::string &prefix="DICe_solution", const bool separate_files_per_subset=false, const bool separate_header_file=false, const bool no_text_output=false) |
| Write the solution vector to a text file. More...
|
|
void | write_stats (const std::string &output_folder, const std::string &prefix="DICe_solution") |
| Write the stats for a completed run. More...
|
|
void | write_deformed_subsets_image (const bool use_gamma_as_color=false) |
| Write an image that shows all the subsets' current positions and shapes using the current field values. More...
|
|
void | write_reference_subset_intensity_image (Teuchos::RCP< Objective > obj) |
| Write an image for each subset that shows the reference intensities for this frame. More...
|
|
void | write_deformed_subset_intensity_image (Teuchos::RCP< Objective > obj) |
| Write an image for each subset that shows the deformed intensities for this frame. More...
|
|
void | write_deformed_subsets_image_new () |
| Write an image that shows all the subsets current position and shape field values from. More...
|
|
void | check_for_blocking_subsets (const int_t subset_global_id) |
| See if any of the subsets have crossed each other's paths blocking each other. More...
|
|
void | generic_correlation_routine (Teuchos::RCP< Objective > obj) |
| Orchestration of how the correlation is conducted. A correlation routine involves a number of steps. The first is to initialize a guess for the given subset, followed by actually performing the correlation. There are a number of checks that happen along the way. The user can request that the initial guess provide a matching gamma value that is below a certain threshold. The user can also request that the final solution meet certain criteria. There are a coupl different approaches to the correlation itself. Using the DICe::GRADIENT_BASED method is similar to most other gradient-based techniques wherein the image gradients provided by the speckle pattern drive the optimization routine to the solution. The DICe::SIMPLEX method on the other hand does not require image gradients. It uses a sophisticated bisection-like technique to arrive at the solution. More...
|
|
bool | motion_detected (const int_t subset_gid) |
|
void | record_failed_step (const int_t subset_gid, const int_t status, const int_t num_iterations) |
|
void | record_step (Teuchos::RCP< Objective > obj, Teuchos::RCP< Local_Shape_Function > shape_function, const scalar_t &sigma, const scalar_t &match, const scalar_t &gamma, const scalar_t &beta, const scalar_t &noise, const scalar_t &contrast, const int_t active_pixels, const int_t status, const int_t num_iterations) |
|
bool | use_objective_regularization () const |
| Returns true if regularization should be used in the objective evaluation.
|
|
bool | use_incremental_formulation () const |
| returns true if the incremental formulation is used
|
|
bool | use_nonlinear_projection () const |
| returns true if the nonlinear projection is used
|
|
Shape_Function_Type | shape_function_type () const |
| Returns true if all quadratic shape functions are enabled.
|
|
bool | translation_enabled () const |
| Returns true if translation shape functions are enabled.
|
|
bool | rotation_enabled () const |
| Returns true if rotation shape functions are enabled.
|
|
bool | normal_strain_enabled () const |
| Returns true if normal strain shape functions are enabled.
|
|
bool | shear_strain_enabled () const |
| Returns true if shear strain shape functions are enabled.
|
|
bool | output_deformed_subset_images () const |
| Print images with the deformed shape of the subset:
|
|
bool | output_evolved_subset_images () const |
| Print images with the evolved intensity profile.
|
|
bool | output_beta () const |
| Returns true if the beta parameter is computed by the objective.
|
|
bool | write_exodus_output () const |
| Returns true if exodus output should be written.
|
|
bool | use_subset_evolution () const |
| Evolve subsets as more pixels become visible that were previously obstructed.
|
|
bool | skip_all_solves () const |
| Returns true if all solves should be skipped.
|
|
bool | normalize_gamma_with_active_pixels () const |
| True if the gamma values should be normalized by the number of active pixels.
|
|
void | set_normalize_gamma_with_active_pixels (const bool flag) |
|
void | set_shape_function_type (const Shape_Function_Type sft) |
| Enable translation shape functions.
|
|
void | enable_translation (const bool flag) |
| Enable translation shape functions.
|
|
void | enable_rotation (const bool flag) |
| Enable rotation shape functions.
|
|
void | enable_normal_strain (const bool flag) |
| Enable normal strain shape functions.
|
|
void | enable_shear_strain (const bool flag) |
| Enable shear strain shape functions.
|
|
void | update_frame_id () |
| Updates the current image frame number.
|
|
int_t | frame_id () const |
| Returns the current image frame (Nonzero only if multiple images are included in the sequence)
|
|
int_t | first_frame_id () const |
| Returns the first image frame (Nonzero only if multiple images are included in the sequence)
|
|
void | set_frame_range (const int_t start_id, const int_t num_frames, const int_t frame_skip) |
|
int_t | num_frames () const |
| Returns the number of images in the set (-1 if it has not been set)
|
|
bool | has_output_spec () const |
| Returns true if the output has a specific order to the fields.
|
|
double | obstruction_skin_factor () const |
| Returns the size of the obstruction skin.
|
|
double | levenberg_marquardt_regularization_factor () const |
| Returns the factor to use for regularization.
|
|
int_t | pixel_integration_order () const |
| Returns the integration order for each pixel.
|
|
const std::vector< Teuchos::RCP< Post_Processor > > * | post_processors () |
| Return access to the post processors vector.
|
|
std::vector< int_t > * | pixels_owning_element_global_id () |
| Provide access to the list of owning elements for each pixel.
|
|
double | theta_jump_tol () const |
| Return the jump tolerance for rotations.
|
|
double | disp_jump_tol () const |
| Return the jump tolerance for displacements.
|
|
void | set_path_file_names (Teuchos::RCP< std::map< int_t, std::string > > path_file_names) |
|
void | set_skip_solve_flags (Teuchos::RCP< std::map< int_t, std::vector< int_t > > > skip_solve_flags) |
|
Teuchos::RCP< std::map< int_t, std::vector< int_t > > > | skip_solve_flags () const |
| Returns a pointer to the skip solve flags.
|
|
void | set_optical_flow_flags (Teuchos::RCP< std::map< int_t, bool > > optical_flow_flags) |
|
void | set_motion_window_params (Teuchos::RCP< std::map< int_t, Motion_Window_Params > > motion_window_params) |
|
Teuchos::RCP< std::map< int_t, Motion_Window_Params > > | motion_window_params () |
| returns a pointer to the motion window params of the schema
|
|
bool | has_initial_condition_file () const |
| returns true if an initial condition file has been specified
|
|
std::string | initial_condition_file () const |
| returns the string name of the initial conditions file
|
|
void | estimate_resolution_error (const Teuchos::RCP< Teuchos::ParameterList > &correlation_params, std::string &output_folder, std::string &resolution_output_folder, std::string &prefix, Teuchos::RCP< std::ostream > &outStream) |
|
void | set_obstructing_subset_ids (Teuchos::RCP< std::map< int_t, std::vector< int_t > > > id_vec) |
| EXPERIMENTAL sets the layering order of subets. More...
|
|
void | set_force_simplex (Teuchos::RCP< std::set< int_t > > ids) |
| forces simplex method for certain subsets More...
|
|
int_t | subset_global_id (const int_t local_id) |
|
int_t | subset_local_id (const int_t global_id) |
|
Teuchos::RCP< Teuchos::ParameterList > | get_params () |
| Returns a pointer to the params that were used to construct this schema.
|
|
Teuchos::RCP< Stat_Container > | stat_container () |
| returns a pointer to the stats class
|
|
std::vector< Teuchos::RCP< Objective > > * | obj_vec () |
| return a pointer to the objective vector
|
|
Teuchos::RCP< DICe::mesh::Mesh > & | mesh () |
| return a pointer to the mesh object that holds all the fields and maps
|
|
std::vector< int_t > | this_proc_gid_order () const |
| return a copy of the gid order for this processor
|
|
Teuchos::RCP< Image_Deformer > | image_deformer () const |
| returns a pointer to the image deformer used for error estimation
|
|
|
comm_rcp | comm_ |
| Pointer to communicator (can be serial)
|
|
Teuchos::RCP< DICe::mesh::Mesh > | mesh_ |
|
std::vector< int_t > | this_proc_gid_order_ |
| Keeps track of the order of gids local to this process.
|
|
std::vector< Teuchos::RCP< Objective > > | obj_vec_ |
| Vector of objective classes.
|
|
Teuchos::RCP< Image > | ref_img_ |
| Pointer to reference image.
|
|
std::vector< Teuchos::RCP< Image > > | def_imgs_ |
|
std::vector< Teuchos::RCP< Image > > | prev_imgs_ |
|
std::vector< Teuchos::RCP< Post_Processor > > | post_processors_ |
| Vector of pointers to the post processing utilities.
|
|
bool | has_post_processor_ |
| True if any post_processors have been activated.
|
|
std::map< int_t, Teuchos::RCP< Initializer > > | opt_initializers_ |
| map of pointers to initializers (used to initialize first guess for optimization routine)
|
|
std::map< int_t, Teuchos::RCP< Motion_Test_Utility > > | motion_detectors_ |
| vector of pointers to motion detectors for a specific subset
|
|
std::vector< int_t > | pixels_owning_element_global_id_ |
| For constrained optimiation, this lists the owning element global id for each pixel:
|
|
int_t | subset_dim_ |
| Connectivity matrix for the global DIC method. More...
|
|
int_t | step_size_x_ |
| Regular grid subset spacing in x direction (used only if subsets are not conformal)
|
|
int_t | step_size_y_ |
| Regular grid subset spacing in y direction (used only if subsets are not conformal)
|
|
Teuchos::RCP< std::map< int_t, Conformal_Area_Def > > | conformal_subset_defs_ |
| Map of subset id and geometry definition.
|
|
int_t | max_evolution_iterations_ |
| Maximum number of iterations in the subset evolution routine.
|
|
int_t | max_solver_iterations_fast_ |
| Maximum solver iterations for computeUpdateFast() for an objective.
|
|
int_t | max_solver_iterations_robust_ |
| Maximum solver iterations for computeUpdateRobust() for an objective.
|
|
double | fast_solver_tolerance_ |
| Fase solver convergence tolerance.
|
|
double | robust_solver_tolerance_ |
| Robust solver convergence tolerance.
|
|
double | skip_solve_gamma_threshold_ |
| If gamma is less than this for the initial guess, the solve is skipped.
|
|
bool | skip_all_solves_ |
| skip the solve for all subsets and just use the initial guess as the solution
|
|
int_t | global_num_subsets_ |
| The global number of correlation points.
|
|
int_t | local_num_subsets_ |
| The local number of correlation points.
|
|
bool | has_output_spec_ |
| Are the output fields and columns specified by the user?
|
|
Teuchos::RCP< DICe::Output_Spec > | output_spec_ |
| Determines how the output is formatted.
|
|
int_t | frame_id_ |
| Stores current fame number for a sequence of images.
|
|
int_t | first_frame_id_ |
| Stores the offset to the first image's index (cine files can start with a negative index)
|
|
int_t | frame_skip_ |
| Stores the striding of the frames.
|
|
int_t | num_frames_ |
| Stores the number of images in the sequence.
|
|
double | disp_jump_tol_ |
|
double | theta_jump_tol_ |
|
double | robust_delta_disp_ |
| int_t of the variation to apply to the initial displacement guess used to construct the simplex
|
|
double | robust_delta_theta_ |
| int_t of the variation to apply to the initial rotation guess used to construct the simplex
|
|
int_t | pixel_integration_order_ |
| Determines how many subdivisions each pixel is cut into for integration purposes.
|
|
double | obstruction_skin_factor_ |
| Factor that increases or decreases the size of obstructions.
|
|
Correlation_Routine | correlation_routine_ |
| DICe::Correlation_Routine.
|
|
Interpolation_Method | interpolation_method_ |
| DICe::Interpolation_Method.
|
|
Gradient_Method | gradient_method_ |
| DICe::Interpolation_Method.
|
|
Optimization_Method | optimization_method_ |
| DICe::Optimization_Method.
|
|
Initialization_Method | initialization_method_ |
| DICe::Initialization_Method.
|
|
Projection_Method | projection_method_ |
| DICe::Projection_Method.
|
|
Analysis_Type | analysis_type_ |
| Analysis type.
|
|
Shape_Function_Type | shape_function_type_ |
| Shape function type.
|
|
bool | enable_translation_ |
| Enable translation.
|
|
bool | enable_rotation_ |
| Enable rotation.
|
|
bool | enable_normal_strain_ |
| Enable normal strain.
|
|
bool | enable_shear_strain_ |
| Enable shear strain.
|
|
Teuchos::RCP< std::map< int_t, std::vector< int_t > > > | obstructing_subset_ids_ |
| If subsets cross paths and obstruct each other, the obstructed pixels are removed for the blocked subset this vector stores a vector of obstructing subset ids that have the potential to block the subset associated with the outer vector index.
|
|
Teuchos::RCP< std::set< int_t > > | force_simplex_ |
| force simplex for these ids
|
|
bool | gauss_filter_images_ |
| filter the images using a gauss_filter_mask_size_ point gauss filter
|
|
bool | filter_failed_cine_pixels_ |
| filter the images using a gauss_filter_mask_size_ point gauss filter
|
|
int_t | gauss_filter_mask_size_ |
| filter the images using a gauss_filter_mask_size_ point gauss filter
|
|
bool | compute_ref_gradients_ |
| Compute the reference image gradients.
|
|
bool | compute_def_gradients_ |
| Compute the deformed image gradients.
|
|
bool | output_deformed_subset_images_ |
| Output images of the deformed subsets at each frame (shapes not intensity profiles)
|
|
bool | output_deformed_subset_intensity_images_ |
| Output images of the deformed subsets at each frame (intensity profiles)
|
|
bool | output_evolved_subset_images_ |
| Output images of the evolved subset at each frame.
|
|
bool | use_subset_evolution_ |
| Use subset evolution (Fill in the reference subset pixels as they become visible in subsequent frames)
|
|
bool | override_force_simplex_ |
| override the forcing of simplex method for blocking subsets
|
|
bool | normalize_gamma_with_active_pixels_ |
| True if the gamma values (match quality) should be normalized with the number of active pixels.
|
|
double | levenberg_marquardt_regularization_factor_ |
| regularization factor
|
|
bool | is_initialized_ |
| Solution vector and subsets are initialized.
|
|
Teuchos::RCP< Teuchos::ParameterList > | init_params_ |
| Pointer to the parameters whith which this schema was initialized.
|
|
Rotation_Value | ref_image_rotation_ |
| Rotate the reference image by 180 degrees.
|
|
Rotation_Value | def_image_rotation_ |
| Rotate the defomed image by 180 degrees.
|
|
Teuchos::RCP< std::map< int_t, std::string > > | path_file_names_ |
| Map to hold the names of the path files for each subset.
|
|
Teuchos::RCP< std::map< int_t, bool > > | optical_flow_flags_ |
| Map to optical flow initializers.
|
|
Teuchos::RCP< std::map< int_t, std::vector< int_t > > > | skip_solve_flags_ |
|
Teuchos::RCP< std::map< int_t, Motion_Window_Params > > | motion_window_params_ |
|
double | initial_gamma_threshold_ |
| tolerance for initial gamma
|
|
double | final_gamma_threshold_ |
| tolerance for final gamma
|
|
double | path_distance_threshold_ |
| tolerance for max_path_distance
|
|
bool | output_beta_ |
| true if the beta parameter should be computed by the objective
|
|
bool | write_exodus_output_ |
| true if exodus output should be written
|
|
bool | use_search_initialization_for_failed_steps_ |
| true if search initialization should be used for failed steps (otherwise the subset is skipped)
|
|
Teuchos::RCP< Stat_Container > | stat_container_ |
| keep track of stats for each subset (only for tracking routine)
|
|
bool | use_incremental_formulation_ |
| use the previous image as the reference rather than the original ref image
|
|
bool | sort_txt_output_ |
| sort the txt output for full field results by coordinates so that they are in ascending order x, then y
|
|
std::string | initial_condition_file_ |
| name of the file to read for the initial condition
|
|
bool | use_nonlinear_projection_ |
| project the right image onto the left frame of reference using a nonlinear projection
|
|
bool | has_extents_ |
| true if only certain portions of the images should be loaded (for example in parallel for large images)
|
|
std::vector< int_t > | ref_extents_ |
| vector that contains the x and y extents for the reference images (x_start_ref, x_end_ref, y_start_ref, y_end_ref)
|
|
std::vector< int_t > | def_extents_ |
| vector that contains the x and y extents for the deformed images (x_start_def, x_end_def, y_start_def, y_end_def)
|
|
int_t | full_ref_img_width_ |
| store the total image dims (the image size before decomposition across processors)
|
|
int_t | full_ref_img_height_ |
| store the total image dims (the image size before decomposition across processors)
|
|
Teuchos::RCP< Image_Deformer > | image_deformer_ |
| store a pointer to the image deformer if this is a error estimation run
|
|
bool | compute_laplacian_image_ |
| true if the laplacian images should be computed
|
|
int_t | threshold_block_size_ |
| size of threshold to use for feature matching when thresholding is included
|
|