Digital Image Correlation Engine  Version 1.0
A modular, high-performance, image correlation tool used to compute full-field displacements and strains from digital images
Namespaces | Classes | Functions
DICe Namespace Reference

generic DICe classes and functions More...

Namespaces

 cine
 cine file format utilities
 
 field_enums
 Field names and properties.
 
 mesh
 computational mesh utilities associated with the global DIC method and physics
 
 utils
 utilities that wont build with NVCC so they are separated out into another namespace
 

Classes

class  Affine_Homography_Simplex
 a simplex that performs an affine homography transformation More...
 
class  Affine_Shape_Function
 six parameter seperable shape function (individual modes can be turned on or off More...
 
class  Altitude_Post_Processor
 A specific instance of post processor that computes the altitude of each subset in reference to the center of the Earth. Used for satellite stereo correlation only. More...
 
struct  Boundary_Condition_Def
 Holds info used to define a boundary condition. More...
 
class  Camera
 A class for camera calibration parameters and computing single camera projection based transformations. More...
 
class  Camera_System
 A class for camera calibration parameters and computing projection transformations notes: there is only one source camera per camera system, this determines how the coordinate systems are organized. All other cameras are target cameras. More...
 
class  Circle
 A circle is a DICe::Shape defined by a centroid and radius. More...
 
class  Command_Line_Parser
 Parses the input options from the command line. More...
 
struct  computed_point
 struct used to sort solutions by peak values More...
 
class  Conformal_Area_Def
 A simple container for geometry information defining the boundary of a DICe::Subset. More...
 
class  ConstantValue_Image_Deformer
 a class that provides an exact solution that is constant valued The image deforming More...
 
class  Correlation_Parameter
 Simple struct to hold information about correlation parameters. More...
 
class  Decomp
 decomposes the images and the mesh points for parallel execution. More...
 
struct  def_triad
 Deformation triad to store three parameter values in a set. More...
 
class  DICChallenge14_Image_Deformer
 a class that deformed an input image according to a sin() function in y More...
 
class  Extents
 collection of origin x, y and width and height More...
 
class  Feature_Matching_Initializer
 an initializer that uses nearby feature matching to initialize the solution More...
 
class  Field_Value_Initializer
 an initializer that grabs values from the field values in the schema as the first guess, for example, the last frame's solution or a neighbor's values More...
 
class  Homography_Simplex
 a derived optimization class specific for image homography between two cameras More...
 
class  Image
 
class  Image_Deformer
 base class that deformes an input image according to an analytical function More...
 
class  Image_Registration_Initializer
 an initializer that uses an ECC transform to initialize the fields More...
 
class  Initializer
 A generic class that provides an initial guess for the optimization routines in a DICe::Objective. More...
 
struct  Intensity_Sum_Functor
 mean value functor More...
 
struct  Intensity_Sum_Minus_Mean_Functor
 Functor to compute the sum minus the mean (value used in ZNSSD criteria) More...
 
class  Live_Plot_Post_Processor
 A specific instance of post processor that computes values of key quantities at specified points. More...
 
class  Local_Shape_Function
 
struct  Mask_Apply_Functor
 image mask apply functor More...
 
struct  Mask_Init_Functor
 image mask initialization functor note, the number of pixels is the size of the x and y arrays, not the image More...
 
struct  Mask_Smoothing_Functor
 image mask initialization functor note, the number of pixels is the size the image More...
 
class  Matrix
 Generic class for matrix storage and operations The idea behind this matrix class is to have a simple matrix (and vector) class that has all it's storage on the stack and several of it's methods optimized. This class is intended for small size matrices that are used in things like objective calculations of other heavily repeated operations. It is not intended for use with dynamic sizes. In most cases the size should be known at compile time. In a few instances the size is not known (for example when there are different sets of shape functions activated by the user, this leads to runtime sizing of the tangent matrix in the subset-based optimization loop). In cases like these, functionality for dynamic sizing has been emulated by making a Matrix of MAX_MATRIX_DIM size and only uses a portion of that allocation. More...
 
class  Motion_Test_Utility
 tests to see if there has been any motion since the last frame if not, this frame can be skipped. More...
 
struct  Motion_Window_Params
 struct to hold motion window around a subset to test for movement More...
 
class  MultiField
 A container class for the data structures used in DICe This class was created to enable switching back and forth between data structures based on the compute architecture. More...
 
class  MultiField_Comm
 MPI Communicator. More...
 
class  MultiField_Exporter
 An exporter directs the tranfer of information between distributed objects. More...
 
class  MultiField_Importer
 An importer directs the tranfer of information between distributed objects. More...
 
class  MultiField_Map
 MPI distribution map. More...
 
class  MultiField_Matrix
 A container class for a CrsMatrix. More...
 
class  NLVC_Strain_Post_Processor
 A specific instance of post processor that computes Nonlocal Vector Calculus (NLVC) strains. More...
 
class  Objective
 A container class for the subsets, optimization algorithm and initialization routine used to correlate a single point. More...
 
class  Objective_ZNSSD
 Sum squared differences DICe::Objective (with and without zero normalization) the criteria is $ \gamma = \sum_i (\frac{G_i - \bar{G}}{\sqrt(\sum_i(G_i - \bar{G})^2)} - \frac{F_i - \bar{F}}{\sqrt(\sum_i(F_i - \bar{F})^2)})^2 $. Normalization is activated when the user selects ZNSSD as the correlation_criteria. ZNSSD performs more robustly in image sets where the lighting changes between frames. More...
 
class  Optical_Flow_Initializer
 an initializer that uses optical flow to predict the next location of the subset (Lucas-Kanade algorithm). This initializer is only intended for the TRACKING_ROUTINE correlation routine More...
 
class  Output_Spec
 A simple class to hold the fields to write to the output files and the order to write them. More...
 
class  Path_Initializer
 A class that takes a text file as input and produces a unique set of points to test when initializing a subset. The text file gets filtered down to a certain resolution and then duplicate points are removed. This class is useful when the path of a particular subset is pre-defined, for example in a mechanism. This class also provides some basic methods for testing solution values and finding the nearest point on the path. More...
 
class  Phase_Correlation_Initializer
 A class that computes the phase correlation of the whole image to get the initial values of displacement in x and y. This initializer is good for cases where the objects being tracked are on a larger object that is translating through the frame. More...
 
class  Polygon
 A straight sided DICe::Shape made of an arbitrary number of sides. More...
 
class  Post_Processor
 A class for computing variables based on the field values and associated utilities. More...
 
class  Projection_Shape_Function
 3 parameter projection from cam 0 to cam 1 More...
 
class  Quadratic_Homography_Simplex
 a simplex that performs a quadratic homography transformation More...
 
class  Quadratic_Shape_Function
 12 parameter quadratic mapping for local shape function More...
 
class  Rectangle
 A rectangle is a DICe::Shape defined by a centroid and an x and y size. More...
 
class  Rigid_Body_Shape_Function
 
class  Satellite_Geometry_Initializer
 an initializer that uses camera angles to initialize the solution More...
 
class  Schema
 The centralized container for the correlation plan and parameters. More...
 
class  Search_Initializer
 A class that searches a nearby neighborhood for the subset. More...
 
class  Shape
 Generic class for defining regions in an image. More...
 
class  Simplex
 Non-gradient based optimization algorithm class. More...
 
class  SinCos_Image_Deformer
 a class that deformed an input image according to a sin()*cos() function More...
 
class  Stat_Container
 container class that holds information about a tracking analysis More...
 
class  Subset
 Subsets are used to store temporary collections of pixels for comparison between the reference and deformed images. The data that is stored by a subset is a list of x and y corrdinates of each pixel (this allows for arbitrary shape) and containers for pixel intensity values. More...
 
struct  Subset_File_Info
 Simple struct for passing info back and forth from read_subset_file: More...
 
struct  Subset_Init_Functor
 subset intensity value initialization functor More...
 
class  Subset_Simplex
 a class that peforms a Nelde-Mead type optimization More...
 
struct  Transform_Functor
 image transformation functor given parameters theta, u, and v, transform the given image uses the keys interpolant (TODO add other interpolants) More...
 
class  Triangulation
 A class for computing the triangulation of 3d points from two correlation and a calibration file. More...
 
class  Uncertainty_Post_Processor
 A specific instance of post processor that computes the uncertainty in the DIC displacement estimate. More...
 
class  VSG_Strain_Post_Processor
 A specific instance of post processor that computes vurtual strain gauge (VSG) strain. More...
 
class  Warp_Simplex
 a simplex that performs a nonlinear warp More...
 
class  Zero_Value_Initializer
 an initializer that places zeros in all values More...
 
struct  ZNSSD_Gamma_Functor
 znssd gamma functor More...
 

Functions

DICE_LIB_DLL_EXPORT void create_regular_grid_of_correlation_points (std::vector< scalar_t > &correlation_points, std::vector< int_t > &neighbor_ids, Teuchos::RCP< Teuchos::ParameterList > params, const int_t img_w, const int_t img_h, Teuchos::RCP< DICe::Subset_File_Info > subset_file_info=Teuchos::null, Teuchos::RCP< DICe::Image > image=Teuchos::null, const scalar_t &grad_threshold=0.0)
 Creates a regular square grid of correlation points. More...
 
DICE_LIB_DLL_EXPORT bool valid_correlation_point (const int_t x_coord, const int_t y_coord, const int_t subset_size, const int_t img_w, const int_t img_h, std::set< std::pair< int_t, int_t > > &coords, std::set< std::pair< int_t, int_t > > &excluded_coords, Teuchos::RCP< DICe::Image > image=Teuchos::null, const scalar_t &grad_threshold=0.0)
 Test to see that the point falls with the boundary of a conformal def and not in the excluded area. More...
 
bool operator< (const def_triad &lhs, const def_triad &rhs)
 
bool operator== (const def_triad &lhs, const def_triad &rhs)
 
DICE_LIB_DLL_EXPORT void stringToUpper (std::string &s)
 Convert a string to all upper case.
 
DICE_LIB_DLL_EXPORT void stringToLower (std::string &s)
 Convert a string to all lower case.
 
const DICE_LIB_DLL_EXPORT std::string to_string (Status_Flag in)
 Convert the status flag to a string.
 
const DICE_LIB_DLL_EXPORT std::string to_string (Correlation_Routine in)
 Convert a DICe::Correlation_Routine to string.
 
const DICE_LIB_DLL_EXPORT std::string to_string (Projection_Method in)
 Convert a DICe::Projection_Method to string.
 
const DICE_LIB_DLL_EXPORT std::string to_string (Global_Formulation in)
 Convert a DICe::Projection_Method to string.
 
const DICE_LIB_DLL_EXPORT std::string to_string (Initialization_Method in)
 Convert a DICe::Initialization_Method to string.
 
const DICE_LIB_DLL_EXPORT std::string to_string (Optimization_Method in)
 Convert a DICe::Optimization_Method to string.
 
const DICE_LIB_DLL_EXPORT std::string to_string (Shape_Function_Type in)
 Convert a DICe::Shape_Function_Type to string.
 
const DICE_LIB_DLL_EXPORT std::string to_string (Interpolation_Method in)
 Convert a DICe::Interpolation_Method to string.
 
const DICE_LIB_DLL_EXPORT std::string to_string (Gradient_Method in)
 Convert a DICe::Gradient_Method to string.
 
const DICE_LIB_DLL_EXPORT std::string to_string (Global_EQ_Term in)
 Convert a DICe::Global_EQ_Term to string.
 
const DICE_LIB_DLL_EXPORT std::string to_string (Global_Solver in)
 Convert a DICe::Global_Solver to string.
 
DICE_LIB_DLL_EXPORT Global_Solver string_to_global_solver (std::string &in)
 Convert a string to a DICe::Global_Solver.
 
DICE_LIB_DLL_EXPORT Correlation_Routine string_to_correlation_routine (std::string &in)
 Convert a string to a DICe::Correlation_Routine.
 
DICE_LIB_DLL_EXPORT Projection_Method string_to_projection_method (std::string &in)
 Convert a string to a DICe::Projection_Method.
 
DICE_LIB_DLL_EXPORT Global_Formulation string_to_global_formulation (std::string &in)
 Convert a string to a DICe::Projection_Method.
 
DICE_LIB_DLL_EXPORT Initialization_Method string_to_initialization_method (std::string &in)
 Convert a string to a DICe::Initialization_Method.
 
DICE_LIB_DLL_EXPORT Interpolation_Method string_to_interpolation_method (std::string &in)
 Convert a string to a DICe::Interpolation_Method.
 
DICE_LIB_DLL_EXPORT Gradient_Method string_to_gradient_method (std::string &in)
 Convert a string to a DICe::Interpolation_Method.
 
DICE_LIB_DLL_EXPORT Shape_Function_Type string_to_shape_function_type (std::string &in)
 Convert a string to a DICe::Shape_Function_Type.
 
DICE_LIB_DLL_EXPORT Optimization_Method string_to_optimization_method (std::string &in)
 Convert a string to a DICe::Optimization_Method.
 
DICE_LIB_DLL_EXPORT bool is_string_param (const std::string &in)
 Determine if the parameter is a string parameter.
 
DICE_LIB_DLL_EXPORT void tracking_default_params (Teuchos::ParameterList *defaultParams)
 Returns a pointer to a ParameterList with default params specified. More...
 
DICE_LIB_DLL_EXPORT void dice_default_params (Teuchos::ParameterList *defaultParams)
 Sets the default correlation parameters. More...
 
DICE_LIB_DLL_EXPORT void to_upper (std::string &s)
 Convert a string to all upper case.
 
DICE_LIB_DLL_EXPORT void to_lower (std::string &s)
 Convert a string to all lower case.
 
DICE_LIB_DLL_EXPORT std::istream & safeGetline (std::istream &is, std::string &t)
 
DICE_LIB_DLL_EXPORT std::vector< std::string > tokenize_line (std::istream &dataFile, const std::string &delim=" \t", const bool capitalize=true)
 Turns a string read from getline() into tokens. More...
 
DICE_LIB_DLL_EXPORT bool is_number (const std::string &s)
 Determines if a string is a number. More...
 
const DICE_LIB_DLL_EXPORT Teuchos::RCP< Subset_File_Inforead_subset_file (const std::string &fileName, const int_t width=-1, const int_t height=-1)
 Read a list of coordinates for correlation points from file. More...
 
DICE_LIB_DLL_EXPORT Teuchos::RCP< DICe::Circleread_circle (std::fstream &dataFile)
 Read a circle from the input file. More...
 
DICE_LIB_DLL_EXPORT Teuchos::RCP< DICe::Rectangleread_rectangle (std::fstream &dataFile)
 Read a circle from the input file. More...
 
DICE_LIB_DLL_EXPORT Teuchos::RCP< DICe::Polygonread_polygon (std::fstream &dataFile)
 Read a polygon from the input file. More...
 
DICE_LIB_DLL_EXPORT multi_shape read_shapes (std::fstream &dataFile)
 Read Several shapes from the subset file. More...
 
DICE_LIB_DLL_EXPORT std::string file_name_no_dir_or_extension (const std::string &file_name)
 returns a string with only the name, no extension or directory
 
DICE_LIB_DLL_EXPORT Teuchos::RCP< Teuchos::ParameterList > parse_command_line (int argc, char *argv[], bool &force_exit, Teuchos::RCP< std::ostream > &outStream)
 Parses the options set in the command line when dice is invoked. More...
 
DICE_LIB_DLL_EXPORT Teuchos::RCP< Teuchos::ParameterList > read_correlation_params (const std::string &paramFileName)
 Read the correlation parameters from a file. More...
 
DICE_LIB_DLL_EXPORT Teuchos::RCP< Teuchos::ParameterList > read_input_params (const std::string &paramFileName)
 Read the input parameters from a file. More...
 
DICE_LIB_DLL_EXPORT void decipher_image_file_names (Teuchos::RCP< Teuchos::ParameterList > params, std::vector< std::string > &image_files, std::vector< std::string > &stero_image_files, int_t &frame_id_start, int_t &num_frames, int_t &frame_skip)
 Converts params into string names of all the images in a sequence. More...
 
DICE_LIB_DLL_EXPORT void generate_template_input_files (const std::string &file_prefix)
 Create template input files with lots of comments. More...
 
DICE_LIB_DLL_EXPORT void create_directory (const std::string &folder)
 create a directory
 
bool frame_should_be_skipped (const int_t trigger_based_frame_index, std::vector< int_t > &frame_id_vector)
 
DICE_LIB_DLL_EXPORT Teuchos::SerialDenseMatrix< int_t, double > compute_affine_matrix (const std::vector< scalar_t > proj_xl, const std::vector< scalar_t > proj_yl, const std::vector< scalar_t > proj_xr, const std::vector< scalar_t > proj_yr)
 
DICE_LIB_DLL_EXPORT void update_legacy_txt_cal_input (const Teuchos::RCP< Teuchos::ParameterList > &input_params)
 
DICE_LIB_DLL_EXPORT void update_vic3d_cal_input (const Teuchos::RCP< Teuchos::ParameterList > &input_params)
 
void initialize_xml_file (const std::string &file_name)
 Create the opening parameter syntax. More...
 
void finalize_xml_file (const std::string &file_name)
 Create the closing parameter syntax. More...
 
void write_xml_comment (const std::string &file_name, const std::string &comment)
 Write a comment to the xml file specified. More...
 
void write_xml_param_list_open (const std::string &file_name, const std::string &name, const bool commented=true)
 Write the opening part of a ParameterList. More...
 
void write_xml_param_list_close (const std::string &file_name, const bool commented=true)
 Write the closing part of a ParameterList. More...
 
void write_xml_param (const std::string &file_name, const std::string &name, const std::string &type, const std::string &value, const bool commented=true)
 Write a general xml parameter to file. More...
 
void write_xml_string_param (const std::string &file_name, const std::string &name, const std::string &value="<value>", const bool commented=true)
 Write a string parameter to file. More...
 
void write_xml_size_param (const std::string &file_name, const std::string &name, const std::string &value="<value>", const bool commented=true)
 Write an integer valued parameter to file. More...
 
void write_xml_size_param (const std::string &file_name, const std::string &name, const int value)
 Write an integer valued parameter to file. More...
 
void write_xml_real_param (const std::string &file_name, const std::string &name, const std::string &value="<value>", const bool commented=true)
 Write a real valued parameter to file. More...
 
void write_xml_real_param (const std::string &file_name, const std::string &name, const double &value)
 Write a real valued parameter to file. More...
 
void write_xml_high_precision_real_param (const std::string &file_name, const std::string &name, const double &value)
 Write a high precision real valued parameter to file. More...
 
void write_xml_bool_param (const std::string &file_name, const std::string &name, const std::string &value="<value>", const bool commented=true)
 Write a boolean valued parameter to file. More...
 
void write_xml_bool_param (const std::string &file_name, const std::string &name, const bool value)
 Write a boolean valued parameter to file. More...
 
void write_xml_bool_literal_param (const std::string &file_name, const std::string &name, const bool value=true, const bool commented=true)
 Write a boolean valued parameter to file. More...
 
void write_xml_file (const std::string &file_name, const Teuchos::ParameterList &params)
 write an xml file based on a teuchos parameter list More...
 
void write_teuchos_parameter (const std::string &file_name, const Teuchos::ParameterList &params, const Teuchos::ParameterList::ConstIterator &it)
 write an individual parameter to the file
 
void write_teuchos_sublist (const std::string &file_name, const Teuchos::ParameterList &params)
 iterate a teuchos sublist and write all the parameters
 
void print_banner ()
 Print the executable information banner.
 
void initialize (int argc, char *argv[])
 
void finalize ()
 Finalize function (mpi and kokkos if enabled):
 
bool default_is_layout_right ()
 returns true if the data layout is LayoutRight
 
void safe_buffer_copy (char *input, char *output)
 
const Correlation_Parameter rotate_ref_image_90_param (rotate_ref_image_90, BOOL_PARAM, true, "True if the reference image should be rotated 90 degrees.")
 Correlation parameter and properties.
 
const Correlation_Parameter rotate_def_image_90_param (rotate_def_image_90, BOOL_PARAM, true, "True if deformed image(s) should be rotated 90 degrees.")
 Correlation parameter and properties.
 
const Correlation_Parameter rotate_ref_image_180_param (rotate_ref_image_180, BOOL_PARAM, true, "True if the reference image should be rotated 180 degrees.")
 Correlation parameter and properties.
 
const Correlation_Parameter rotate_def_image_180_param (rotate_def_image_180, BOOL_PARAM, true, "True if deformed image(s) should be rotated 180 degrees.")
 Correlation parameter and properties.
 
const Correlation_Parameter rotate_ref_image_270_param (rotate_ref_image_270, BOOL_PARAM, true, "True if the reference image should be rotated 270 degrees.")
 Correlation parameter and properties.
 
const Correlation_Parameter rotate_def_image_270_param (rotate_def_image_270, BOOL_PARAM, true, "True if deformed image(s) should be rotated 270 degrees.")
 Correlation parameter and properties.
 
const Correlation_Parameter image_grad_use_hierarchical_parallelism_param (image_grad_use_hierarchical_parallelism, BOOL_PARAM, true, "True if higherarchical parallelism should be used when computing image gradients (parallel in x and y)")
 Correlation parameter and properties.
 
const Correlation_Parameter image_grad_team_size_param (image_grad_team_size, SIZE_PARAM, true, "The team size to use for thread teams when computing image gradients.")
 Correlation parameter and properties.
 
const Correlation_Parameter gauss_filter_use_hierarchical_parallelism_param (gauss_filter_use_hierarchical_parallelism, BOOL_PARAM, true, "True if higherarchical parallelism should be used when computing image Gaussian filter (parallel in x and y)")
 Correlation parameter and properties.
 
const Correlation_Parameter gauss_filter_team_size_param (gauss_filter_team_size, SIZE_PARAM, true, "The team size to use for thread teams when computing Gaussian filter.")
 Correlation parameter and properties.
 
const Correlation_Parameter gauss_filter_mask_size_param (gauss_filter_mask_size, SIZE_PARAM, true, "The size in pixels of the Gaussian filter (3, 5, 7, 9, 11, or 13).")
 Correlation parameter and properties.
 
const Correlation_Parameter pixel_integration_order_param (pixel_integration_order, SIZE_PARAM, true, "Specifies the integration order to use (number of subdivisions for each pixel). Used only in the constrained optimization formulation.")
 Correlation parameter and properties.
 
const Correlation_Parameter threshold_block_size_param (threshold_block_size, SIZE_PARAM, true, "The block size to use for the feature matching initializer when thresholding is enabled.")
 Correlation parameter and properties.
 
const Correlation_Parameter obstruction_skin_factor_param (obstruction_skin_factor, SCALAR_PARAM, true, "Stretches the obstruction subsets to make them larger (factor > 1.0) or smaller (factor < 1.0) than they actually are.")
 Correlation parameter and properties.
 
const Correlation_Parameter exact_solution_dic_challenge_14_param (exact_solution_dic_challenge_14, SCALAR_PARAM, true, "Compute the error between the solution and the DIC Challenge 14 analytic solution")
 Correlation parameter and properties.
 
const Correlation_Parameter exact_solution_constant_value_x_param (exact_solution_constant_value_x, SCALAR_PARAM, true, "Compute the error between the solution and an analytical solution of this constant value")
 Correlation parameter and properties.
 
const Correlation_Parameter exact_solution_constant_value_y_param (exact_solution_constant_value_y, SCALAR_PARAM, true, "Compute the error between the solution and an analytical solution of this constant value")
 Correlation parameter and properties.
 
const Correlation_Parameter estimate_resolution_error_param (estimate_resolution_error, BOOL_PARAM, true, "Only evaluates the error from a known solution synthetically applied to the reference image," " determines the spatial resolution. Integer value affects the wave number of the sin() function")
 Correlation parameter and properties.
 
const Correlation_Parameter estimate_resolution_error_min_period_param (estimate_resolution_error_min_period, SCALAR_PARAM, true, "minimum motion period to use in the estimation of resolution error")
 Correlation parameter and properties.
 
const Correlation_Parameter estimate_resolution_error_max_period_param (estimate_resolution_error_max_period, SCALAR_PARAM, true, "maximum motion period to use in the estimation of resolution error")
 Correlation parameter and properties.
 
const Correlation_Parameter estimate_resolution_error_period_factor_param (estimate_resolution_error_period_factor, SCALAR_PARAM, true, "reduction factor to apply to the period for each step in the estimation of resolution error")
 Correlation parameter and properties.
 
const Correlation_Parameter estimate_resolution_error_min_amplitude_param (estimate_resolution_error_min_amplitude, SCALAR_PARAM, true, "minimum amplitude of the motion to use in the estimation of resolution error")
 Correlation parameter and properties.
 
const Correlation_Parameter estimate_resolution_error_max_amplitude_param (estimate_resolution_error_max_amplitude, SCALAR_PARAM, true, "maximum amplitude of the motion to use in the estimation of resolution error")
 Correlation parameter and properties.
 
const Correlation_Parameter estimate_resolution_error_amplitude_step_param (estimate_resolution_error_amplitude_step, SCALAR_PARAM, true, "amount of amplitude added to the motion amplitude for each step in the estimation of resolution error")
 Correlation parameter and properties.
 
const Correlation_Parameter estimate_resolution_error_speckle_size_param (estimate_resolution_error_speckle_size, SCALAR_PARAM, true, "create synthetic images with speckles of a regular size in the estimation of resolution error")
 Correlation parameter and properties.
 
const Correlation_Parameter estimate_resolution_error_noise_percent_param (estimate_resolution_error_noise_percent, SCALAR_PARAM, true, "amount of noise to add in percent of counts to the deformed image in the estimation of resolution error")
 Correlation parameter and properties.
 
const Correlation_Parameter use_incremental_formulation_param (use_incremental_formulation, BOOL_PARAM, true, "Use the previous image as the reference rather than the original ref image. Displacements become cumulative")
 Correlation parameter and properties.
 
const Correlation_Parameter use_nonlinear_projection_param (use_nonlinear_projection, BOOL_PARAM, true, "Project the right image onto the left frame of reference before correlation using a nonlinear projection operator (used for stereo only)")
 Correlation parameter and properties.
 
const Correlation_Parameter sort_txt_output_param (sort_txt_output, BOOL_PARAM, true, "Sort the text output file according to the subset location in x then y for the full field results")
 Correlation parameter and properties.
 
const Correlation_Parameter output_delimiter_param (output_delimiter, STRING_PARAM, true, "Delimeter to separate column values in output files, (comma or space, etc.)")
 Correlation parameter and properties.
 
const Correlation_Parameter omit_output_row_id_param (omit_output_row_id, BOOL_PARAM, true, "True if the row id should be omitted from the output (column zero is skipped)")
 Correlation parameter and properties.
 
const Correlation_Parameter mms_spec_param (mms_spec, STRING_PARAM, false, "Set of parameters for the method of manufactured solutions problems")
 Correlation parameter and properties.
 
const Correlation_Parameter output_spec_param (output_spec, STRING_PARAM, false, "Determines what output to write and in what order")
 Correlation parameter and properties.
 
const Correlation_Parameter undistort_images_param (undistort_images, STRING_PARAM, false, "Used to undistort the images manually")
 Correlation parameter and properties.
 
const Correlation_Parameter correlation_routine_param (correlation_routine, STRING_PARAM, true, "Determines the correlation order of execution (see DICe::Schema)", correlationRoutineStrings, MAX_CORRELATION_ROUTINE)
 Correlation parameter and properties.
 
const Correlation_Parameter interpolation_method_param (interpolation_method, STRING_PARAM, true, "Determines which interpolation method to use (can also affect the image gradients)", interpolationMethodStrings, MAX_INTERPOLATION_METHOD)
 Correlation parameter and properties.
 
const Correlation_Parameter gradient_method_param (gradient_method, STRING_PARAM, true, "Determines which image gradient method to use", gradientMethodStrings, MAX_GRADIENT_METHOD)
 Correlation parameter and properties.
 
const Correlation_Parameter initialization_method_param (initialization_method, STRING_PARAM, true, "Determines how solution values are initialized for each frame", initializationMethodStrings, MAX_INITIALIZATION_METHOD)
 Correlation parameter and properties.
 
const Correlation_Parameter optimization_method_param (optimization_method, STRING_PARAM, true, "Determines if gradient based (fast, but not as robust) or simplex based (no gradients needed, but requires more iterations) optimization algorithm will be used", optimizationMethodStrings, MAX_OPTIMIZATION_METHOD)
 Correlation parameter and properties.
 
const Correlation_Parameter projection_method_param (projection_method, STRING_PARAM, true, "Determines how solution values from previous frames are used to predict the current solution", projectionMethodStrings, MAX_PROJECTION_METHOD)
 Correlation parameter and properties.
 
const Correlation_Parameter initial_condition_file_param (initial_condition_file, BOOL_PARAM, true, "Denotes a file to read the solution from as the initial condition")
 Correlation parameter and properties.
 
const Correlation_Parameter shape_function_type_param (shape_function_type, STRING_PARAM, true, "Determines what type of shape function is used", shapeFunctionTypeStrings, MAX_SF)
 Correlation parameter and properties.
 
const Correlation_Parameter enable_projection_shape_function_param (enable_projection_shape_function, BOOL_PARAM, true, "Enables the projection based shape function (all components)")
 Correlation parameter and properties.
 
const Correlation_Parameter enable_translation_param (enable_translation, BOOL_PARAM, true, "Enables the translation shape function degrees of freedom (u and v)")
 Correlation parameter and properties.
 
const Correlation_Parameter enable_rotation_param (enable_rotation, BOOL_PARAM, true, "Enables the rotation shape function degree of freedom (theta)")
 Correlation parameter and properties.
 
const Correlation_Parameter enable_normal_strain_param (enable_normal_strain, BOOL_PARAM, true, "Enables the normal strain shape function degrees of freedom (epsilon_x and epsilon_y)")
 Correlation parameter and properties.
 
const Correlation_Parameter enable_shear_strain_param (enable_shear_strain, BOOL_PARAM, true, "Enables the shear strain shape function defree of freedom (gamma_xy = gamma_yx)")
 Correlation parameter and properties.
 
const Correlation_Parameter levenberg_marquardt_regularization_factor_param (levenberg_marquardt_regularization_factor, SCALAR_PARAM, true, "The coefficient applied to the regularization term if active")
 Correlation parameter and properties.
 
const Correlation_Parameter max_evolution_iterations_param (max_evolution_iterations, SIZE_PARAM, true, "Maximum evolution iterations to use (only valid for subset_evolution_routine)")
 Correlation parameter and properties.
 
const Correlation_Parameter max_solver_iterations_fast_param (max_solver_iterations_fast, SIZE_PARAM)
 Correlation parameter and properties.
 
const Correlation_Parameter max_solver_iterations_robust_param (max_solver_iterations_robust, SIZE_PARAM)
 Correlation parameter and properties.
 
const Correlation_Parameter fast_solver_tolerance_param (fast_solver_tolerance, SCALAR_PARAM)
 Correlation parameter and properties.
 
const Correlation_Parameter robust_solver_tolerance_param (robust_solver_tolerance, SCALAR_PARAM)
 Correlation parameter and properties.
 
const Correlation_Parameter skip_all_solves_param (skip_all_solves, BOOL_PARAM, true, "This option will use the initial guess for the displacement solution as the solution and skip the solves. " "It can be helpful for testing if the initialization routine is working properly")
 Correlation parameter and properties.
 
const Correlation_Parameter skip_solve_gamma_threshold_param (skip_solve_gamma_threshold, SCALAR_PARAM, true, "If the gamma evaluation for the initial deformation guess is below this value, the solve is skipped because" " the match is already good enough")
 Correlation parameter and properties.
 
const Correlation_Parameter initial_gamma_threshold_param (initial_gamma_threshold, SCALAR_PARAM, true, "If the gamma evaluation for the initial deformation guess is not below this value, initialization will fail")
 Correlation parameter and properties.
 
const Correlation_Parameter sssig_threshold_param (sssig_threshold, SCALAR_PARAM, true, "filters out areas of the image with low gradients, if a subset has an SSSIG below this value it gets excluded")
 
const Correlation_Parameter final_gamma_threshold_param (final_gamma_threshold, SCALAR_PARAM, true, "If the gamma evaluation for the final deformation guess is not below this value, the step will fail for this subset")
 Correlation parameter and properties.
 
const Correlation_Parameter path_distance_threshold_param (path_distance_threshold, SCALAR_PARAM, true, "If the final deformation solution is farther than this threshold from a segment in the path file" " (which must be specified in the subset file) the step will fail for this subset")
 Correlation parameter and properties.
 
const Correlation_Parameter pixel_size_in_mm_param (pixel_size_in_mm, SCALAR_PARAM, true, "The spatial size of one pixel (1 pixel is equivalent to ? mm")
 Correlation parameter and properties.
 
const Correlation_Parameter disp_jump_tol_param (disp_jump_tol, SCALAR_PARAM, true, "Displacement solutions greater than this from the previous frame will be rejected as unsuccessful")
 Correlation parameter and properties.
 
const Correlation_Parameter theta_jump_tol_param (theta_jump_tol, SCALAR_PARAM, true, "Rotation solutions greater than this from the previous frame will be rejected as unsuccessful")
 Correlation parameter and properties.
 
const Correlation_Parameter robust_delta_disp_param (robust_delta_disp, SCALAR_PARAM, true, "Variation on initial displacement guess used to construct simplex")
 Correlation parameter and properties.
 
const Correlation_Parameter robust_delta_theta_param (robust_delta_theta, SCALAR_PARAM, true, "Variation on initial rotation guess used to construct simplex")
 Correlation parameter and properties.
 
const Correlation_Parameter output_deformed_subset_images_param (output_deformed_subset_images, BOOL_PARAM, true, "Write images that show the deformed position of the subsets (Currently only available for TRACKING_ROUTINE correlation_routine, not GENERIC)")
 Correlation parameter and properties.
 
const Correlation_Parameter output_deformed_subset_intensity_images_param (output_deformed_subset_intensity_images, BOOL_PARAM, true, "Write images that show the intensity profile of the deformed subsets")
 Correlation parameter and properties.
 
const Correlation_Parameter output_evolved_subset_images_param (output_evolved_subset_images, BOOL_PARAM, true, "Write images that show the reference subset as its intensity profile evolves")
 Correlation parameter and properties.
 
const Correlation_Parameter use_subset_evolution_param (use_subset_evolution, BOOL_PARAM, true, "Used to evolve subsets that are initially obscured (Currently only available for TRACKING_ROUTINE correlation routine, not GENERIC)")
 Correlation parameter and properties.
 
const Correlation_Parameter output_beta_param (output_beta, BOOL_PARAM, true, "True if the beta parameter should be computed (still needs to be added to the output spec if it should be included in the output file)" " This parameter measures the distinguishability of a pattern for template matching")
 Correlation parameter and properties.
 
const Correlation_Parameter global_regularization_alpha_param (global_regularization_alpha, SCALAR_PARAM, true, "Used only for global, this is the coefficient for the alpha regularization term")
 Correlation parameter and properties.
 
const Correlation_Parameter global_stabilization_tau_param (global_stabilization_tau, SCALAR_PARAM, true, "Used only for global, this is the stabilization coefficient (overrides automatically calculated one)")
 Correlation parameter and properties.
 
const Correlation_Parameter global_formulation_param (global_formulation, STRING_PARAM, true, "Used only for global, this is the formulation to use (which terms are included, etc.)", globalFormulationStrings, MAX_GLOBAL_FORMULATION)
 Correlation parameter and properties.
 
const Correlation_Parameter global_solver_param (global_solver, STRING_PARAM, true, "Used only for global, this is the solver to use for the global method.")
 Correlation parameter and properties.
 
const Correlation_Parameter use_fixed_point_iterations_param (use_fixed_point_iterations, BOOL_PARAM, true, "Used only for global, uses the fixed point iteration scheme for the global method.")
 Correlation parameter and properties.
 
const Correlation_Parameter write_exodus_output_param (write_exodus_output, BOOL_PARAM, true, "Used when DICE_ENABLE_GLOBAL is true, writes an exodus output file.")
 Correlation parameter and properties.
 
const Correlation_Parameter global_element_type_param (global_element_type, STRING_PARAM, true, "Used only for global, this is the element type to use for the global method.")
 Correlation parameter and properties.
 
const Correlation_Parameter num_image_integration_points_param (num_image_integration_points, SIZE_PARAM, true, "Used only for global, this is the number of integration points (in each dim per element) to use for the global method.")
 Correlation parameter and properties.
 
const Correlation_Parameter use_tracking_default_params_param (use_tracking_default_params, BOOL_PARAM, true, "Use the TRACKING default parameters instead of the GENERIC defaults (Not commonly used).")
 Correlation parameter and properties.
 
const Correlation_Parameter override_force_simplex_param (override_force_simplex, BOOL_PARAM, true, "Override the forcing of the simplex method for blocking subsets or those specified using the force_simplex keyword in the subset definition file.")
 Correlation parameter and properties.
 
const Correlation_Parameter use_search_initialization_for_failed_steps_param (use_search_initialization_for_failed_steps, BOOL_PARAM, true, "Use a searching routine whenever a step fails in the TRACKING_ROUTINE.")
 Correlation parameter and properties.
 
const Correlation_Parameter normalize_gamma_with_active_pixels_param (normalize_gamma_with_active_pixels, BOOL_PARAM, true, "True if the computed gamma value (or matching quality) will be normalized by the number of active pixels.")
 Correlation parameter and properties.
 
const Correlation_Parameter use_global_dic_param (use_global_dic, BOOL_PARAM, false, "True if the global method should be used rather than subset or local DIC.")
 Correlation parameter and properties.
 
const Correlation_Parameter use_constrained_opt_dic_param (use_constrained_opt_dic, BOOL_PARAM, false, "True if the constrained optimization method should be used rather than subset or local DIC.")
 Correlation parameter and properties.
 
const Correlation_Parameter use_integrated_dic_param (use_integrated_dic, BOOL_PARAM, false, "True if the integrated DIC algorithms should be used rather than subset or local DIC.")
 Correlation parameter and properties.
 
const Correlation_Parameter compute_ref_gradients_param (compute_ref_gradients, BOOL_PARAM, false, "Compute image gradients for the reference frame")
 Correlation parameter and properties.
 
const Correlation_Parameter gauss_filter_images_param (gauss_filter_images, BOOL_PARAM, false, "Filter the images using a 7 point gauss filter (eliminates high frequnecy content)")
 Correlation parameter and properties.
 
const Correlation_Parameter time_average_cine_ref_frame_param (time_average_cine_ref_frame, SIZE_PARAM, false, "Select the number of frames over which to time average the reference frame of a cine file")
 Correlation parameter and properties.
 
const Correlation_Parameter compute_def_gradients_param (compute_def_gradients, BOOL_PARAM, false, "Compute image gradients for the deformed image of the current frame")
 Correlation parameter and properties.
 
const Correlation_Parameter compute_image_gradients_param (compute_image_gradients, BOOL_PARAM, false, "Compute image gradients")
 Correlation parameter and properties.
 
const Correlation_Parameter compute_laplacian_image_param (compute_laplacian_image, BOOL_PARAM, false, "Compute the laplacian of the image")
 Correlation parameter and properties.
 
const Correlation_Parameter filter_failed_cine_pixels_param (filter_failed_cine_pixels, BOOL_PARAM, false, "Filter out any pixels that failed during cine acquisition")
 Correlation parameter and properties.
 
const Correlation_Parameter remove_outlier_pixels_param (remove_outlier_pixels, BOOL_PARAM, false, "Remove outlier pixel intensities (usually due to failed pixels)")
 Correlation parameter and properties.
 
void apply_transform (Teuchos::RCP< Image > image_in, Teuchos::RCP< Image > image_out, const int_t cx, const int_t cy, Teuchos::RCP< Local_Shape_Function > shape_function)
 
void compute_roll_off_stats (const scalar_t &period, const scalar_t &img_w, const scalar_t &img_h, Teuchos::RCP< MultiField > &coords, Teuchos::RCP< MultiField > &disp, Teuchos::RCP< MultiField > &exact_disp, Teuchos::RCP< MultiField > &disp_error, scalar_t &peaks_avg_error_x, scalar_t &peaks_std_dev_error_x, scalar_t &peaks_avg_error_y, scalar_t &peaks_std_dev_error_y)
 
Teuchos::RCP< Imagecreate_synthetic_speckle_image (const int_t w, const int_t h, const int_t offset_x, const int_t offset_y, const scalar_t &speckle_size, const Teuchos::RCP< Teuchos::ParameterList > &params=Teuchos::null)
 
void add_noise_to_image (Teuchos::RCP< Image > &image, const scalar_t &noise_percent)
 
int_t compute_speckle_stats (const std::string &output_dir, Teuchos::RCP< Image > &image)
 
Teuchos::RCP< Local_Shape_Functionshape_function_factory (Schema *schema=NULL)
 
template<typename Type >
std::string type_to_string ()
 helper function to turn a type into a string using type_to_string<type>();
 
template<typename Type >
void put_value (Vector< Type > &vec, const Type &value)
 function to set all the values of a vector to one value
 
template<typename Type >
void zero (Vector< Type > &vec)
 function to reset the values of a vector to zero
 
template<typename Type , size_t Rows, size_t Cols>
scalar_t norm (Matrix< Type, Rows, Cols > matrix)
 2 norm of a matrix as a static method
 
template<typename Type , size_t Rows, size_t Cols>
scalar_t one_norm (Matrix< Type, Rows, Cols > matrix)
 function to compute the 1-norm of a matrix (max of the column totals)
 
scalar_t angle_2d (const scalar_t &x1, const scalar_t &y1, const scalar_t &x2, const scalar_t &y2)
 Return the angle between two vectors on a plane The angle is from vector 1 to vector 2, positive anticlockwise The result is between -pi -> pi. More...
 
DICE_LIB_DLL_EXPORT void complex_divide (kiss_fft_cpx *lhs, kiss_fft_cpx *rhs, const int_t size)
 
DICE_LIB_DLL_EXPORT void image_fft (Teuchos::RCP< Image > image, Teuchos::ArrayRCP< scalar_t > &real, Teuchos::ArrayRCP< scalar_t > &complex, const int_t inverse=0, const bool hamming_filter=true)
 
DICE_LIB_DLL_EXPORT Teuchos::RCP< Imageimage_fft (Teuchos::RCP< Image > image, const bool hamming_filter=true, const bool apply_log=true, const scalar_t scale_factor=100.0, bool shift=true, const bool high_pass_filter=false)
 
DICE_LIB_DLL_EXPORT scalar_t phase_correlate_x_y (Teuchos::RCP< Image > image_a, Teuchos::RCP< Image > image_b, scalar_t &u_x, scalar_t &u_y, const bool convert_to_r_theta=false)
 
DICE_LIB_DLL_EXPORT void phase_correlate_row (Teuchos::RCP< Image > image_a, Teuchos::RCP< Image > image_b, const int_t row_id, scalar_t &u, const bool convert_to_theta=false)
 
DICE_LIB_DLL_EXPORT Teuchos::RCP< Imagepolar_transform (Teuchos::RCP< Image > image, const bool high_pass_filter=false)
 
DICE_LIB_DLL_EXPORT void array_2d_fft_in_place (const int_t w, const int_t h, Teuchos::ArrayRCP< scalar_t > &real, Teuchos::ArrayRCP< scalar_t > &complex, const int_t inverse=0)
 
DICE_LIB_DLL_EXPORT void complex_multiply (scalar_t &result_r, scalar_t &result_i, const scalar_t &a_r, const scalar_t &a_i, const scalar_t &b_r, const scalar_t &b_i)
 
DICE_LIB_DLL_EXPORT void complex_abs (scalar_t &result, const scalar_t &a_r, const scalar_t &a_i)
 
DICE_LIB_DLL_EXPORT void complex_divide (scalar_t &result_r, scalar_t &result_i, const scalar_t &a_r, const scalar_t &a_i, const scalar_t &b_r, const scalar_t &b_i)
 
std::string tostring (const field_enums::Field_Type &field_type)
 
std::string tostring (const field_enums::Field_Name &field_name)
 
std::string tostring (const field_enums::Entity_Rank &field_rank)
 
field_enums::Field_Type string_to_field_type (const std::string &input_string)
 
field_enums::Field_Name string_to_field_name (const std::string &input_string)
 
void update_field_names (const field_enums::Field_Name &field_name, const std::string &input_string)
 
int_t num_field_names ()
 returns the number of field names
 
std::list< std::string > get_reverse_sorted_field_names ()
 returns a list of the fields in reverse order
 
field_enums::Entity_Rank string_to_entity_rank (const std::string &input_string)
 
DICE_LIB_DLL_EXPORT void tri3d_natural_integration_points (const int_t order, Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &locations, Teuchos::ArrayRCP< scalar_t > &weights, int_t &num_points)
 
DICE_LIB_DLL_EXPORT void tri2d_natural_integration_points (const int_t order, Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &locations, Teuchos::ArrayRCP< scalar_t > &weights, int_t &num_points)
 
DICE_LIB_DLL_EXPORT void tri2d_nonexact_integration_points (const int_t order, Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &locations, Teuchos::ArrayRCP< scalar_t > &weights, int_t &num_points)
 
DICE_LIB_DLL_EXPORT scalar_t cross (const scalar_t *A, const scalar_t *B, const scalar_t *C)
 
DICE_LIB_DLL_EXPORT scalar_t cross3d (const scalar_t *A, const scalar_t *B, const scalar_t *C)
 
DICE_LIB_DLL_EXPORT scalar_t cross3d_with_normal (const scalar_t *A, const scalar_t *B, const scalar_t *C, scalar_t *normal)
 
DICE_LIB_DLL_EXPORT void cross3d_with_cross_prod (const scalar_t *A, const scalar_t *B, const scalar_t *C, scalar_t *cross_prod)
 
DICE_LIB_DLL_EXPORT scalar_t determinant_4x4 (const scalar_t *a)
 
DICE_LIB_DLL_EXPORT void gauss_1D (Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &r, Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &w, int_t gauss_order)
 
DICE_LIB_DLL_EXPORT void gauss_2D (Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &r, Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &w, int_t gauss_order)
 
DICE_LIB_DLL_EXPORT Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > kronecker (Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &A, Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &B)
 
DICE_LIB_DLL_EXPORT void calc_jacobian (const scalar_t *xcap, const scalar_t *DN, scalar_t *jacobian, scalar_t *inv_jacobian, scalar_t &J, int_t num_elem_nodes, int_t dim)
 
DICE_LIB_DLL_EXPORT void calc_B (const scalar_t *DN, const scalar_t *inv_jacobian, int_t num_elem_nodes, int_t dim, scalar_t *solid_B)
 

Detailed Description

generic DICe classes and functions

Function Documentation

◆ add_noise_to_image()

void DICe::add_noise_to_image ( Teuchos::RCP< Image > &  image,
const scalar_t noise_percent 
)

free function to add noise counts to an image

Parameters
imagethe image to modify
noise_percentthe amount of noise to add in percentage of the maximum intensity

◆ angle_2d()

scalar_t DICe::angle_2d ( const scalar_t x1,
const scalar_t y1,
const scalar_t x2,
const scalar_t y2 
)

Return the angle between two vectors on a plane The angle is from vector 1 to vector 2, positive anticlockwise The result is between -pi -> pi.

Parameters
x1run of vector 1
y1rise of vector 1
x2run of vector 2
y2rise of vector 2

◆ apply_transform()

void DICe::apply_transform ( Teuchos::RCP< Image image_in,
Teuchos::RCP< Image image_out,
const int_t  cx,
const int_t  cy,
Teuchos::RCP< Local_Shape_Function shape_function 
)

free function to apply a transformation to an image:

Parameters
image_inthe image where the intensities are taken
image_outthe output image
cxthe centroid x coordiante
cythe centroid y coordinate
shape_functionstores the vector that defines the deformation map parameters

◆ array_2d_fft_in_place()

DICE_LIB_DLL_EXPORT void DICe::array_2d_fft_in_place ( const int_t  w,
const int_t  h,
Teuchos::ArrayRCP< scalar_t > &  real,
Teuchos::ArrayRCP< scalar_t > &  complex,
const int_t  inverse = 0 
)

2 dimensional FFT of an array

Parameters
wwidth
hheight
realthe real array
complexthe imaginary array
inverse1 if the FFT should be to the time domain

◆ calc_B()

DICE_LIB_DLL_EXPORT void DICe::calc_B ( const scalar_t DN,
const scalar_t inv_jacobian,
int_t  num_elem_nodes,
int_t  dim,
scalar_t solid_B 
)

compute the B matrix for linear elasticity

Parameters
DNthe derivative of the shape functions
inv_jacobianthe inverse of the jacobian matrix
num_elem_nodesThe number of nodes per element
dimspatial dimension
solid_B[out] the output B vector

◆ calc_jacobian()

DICE_LIB_DLL_EXPORT void DICe::calc_jacobian ( const scalar_t xcap,
const scalar_t DN,
scalar_t jacobian,
scalar_t inv_jacobian,
scalar_t J,
int_t  num_elem_nodes,
int_t  dim 
)

calculate the element jacobian

Parameters
xcapthe nodal coordinates
DNthe derivative of the shape functions
jacobianthe jacobian matrix
inv_jacobianinverse of the jacobian matrix
Jthe determinant of the jacobian
num_elem_nodesnumber of nodes per element
dimspatial dimension

◆ complex_abs()

DICE_LIB_DLL_EXPORT void DICe::complex_abs ( scalar_t result,
const scalar_t a_r,
const scalar_t a_i 
)

absolute value of a complex number

Parameters
result[out] the result
a_rthe real part of the complex number
a_ithe imaginary part of the complex number

◆ complex_divide() [1/2]

DICE_LIB_DLL_EXPORT void DICe::complex_divide ( kiss_fft_cpx lhs,
kiss_fft_cpx rhs,
const int_t  size 
)

complex number divide

Parameters
lhsleft hand side
rhsright hand side
sizenumber of elements in the array

◆ complex_divide() [2/2]

DICE_LIB_DLL_EXPORT void DICe::complex_divide ( scalar_t result_r,
scalar_t result_i,
const scalar_t a_r,
const scalar_t a_i,
const scalar_t b_r,
const scalar_t b_i 
)

divide two complex numbers

Parameters
result_r[out] the real result
result_i[out] the imaginary result
a_rthe left hand side real part
a_ithe left hand side imaginary part
b_rthe right hand side real part
b_ithe right hand side imaginary part

◆ complex_multiply()

DICE_LIB_DLL_EXPORT void DICe::complex_multiply ( scalar_t result_r,
scalar_t result_i,
const scalar_t a_r,
const scalar_t a_i,
const scalar_t b_r,
const scalar_t b_i 
)

multiply two complex numbers

Parameters
result_r[out] the real result
result_i[out] the imaginary result
a_rthe left hand side real part
a_ithe left hand side imaginary part
b_rthe right hand side real part
b_ithe right hand side imaginary part

◆ compute_affine_matrix()

DICE_LIB_DLL_EXPORT Teuchos::SerialDenseMatrix<int_t,double> DICe::compute_affine_matrix ( const std::vector< scalar_t proj_xl,
const std::vector< scalar_t proj_yl,
const std::vector< scalar_t proj_xr,
const std::vector< scalar_t proj_yr 
)

free function to estimate a 9 parameter affine projection

Parameters
proj_xlx coordinates of the points in the left image or coordinate system
proj_yly coordinates of the points in the left image or coordinate system
proj_xrx coordinates of the points in the right image or coordinate system
proj_yry coordinates of the points in the right image or coordinate system return value affine_matrix storage for the affine parameters (must be 3x3)

◆ compute_roll_off_stats()

void DICe::compute_roll_off_stats ( const scalar_t period,
const scalar_t img_w,
const scalar_t img_h,
Teuchos::RCP< MultiField > &  coords,
Teuchos::RCP< MultiField > &  disp,
Teuchos::RCP< MultiField > &  exact_disp,
Teuchos::RCP< MultiField > &  disp_error,
scalar_t peaks_avg_error_x,
scalar_t peaks_std_dev_error_x,
scalar_t peaks_avg_error_y,
scalar_t peaks_std_dev_error_y 
)

free function to compute the roll off statistics for the peaks in the exact solution

Parameters
period,theperiod of the exact displacement
img_wthe width of the image
img_hthe height of the image
coordsthe coordinates field
dispthe computed displacement field
exact_dispthe exact displacement field
disp_errorthe error field
peaks_avg_error_x[out] computed stat
peaks_std_dev_error_x[out] computed stat
peaks_avg_error_y[out] computed stat
peaks_std_dev_error_y[out] computed stat

◆ compute_speckle_stats()

int_t DICe::compute_speckle_stats ( const std::string &  output_dir,
Teuchos::RCP< Image > &  image 
)

free function to determine the distribution of speckle sizes returns the next largest odd integer size (so if the pattern predominant size is 6, the function returns 7)

Parameters
output_dirthe directory to save the statistics file in
imagethe image containing the speckle pattern should only be run on processor zero (has no parallel smarts)

◆ create_regular_grid_of_correlation_points()

DICE_LIB_DLL_EXPORT void DICe::create_regular_grid_of_correlation_points ( std::vector< scalar_t > &  correlation_points,
std::vector< int_t > &  neighbor_ids,
Teuchos::RCP< Teuchos::ParameterList >  params,
const int_t  img_w,
const int_t  img_h,
Teuchos::RCP< DICe::Subset_File_Info subset_file_info = Teuchos::null,
Teuchos::RCP< DICe::Image image = Teuchos::null,
const scalar_t grad_threshold = 0.0 
)

Creates a regular square grid of correlation points.

Parameters
correlation_pointsVector of global point coordinates
neighbor_idslist the neighbor to use for initialization if done with USE_NEIGHBOR_VALUES
paramsUsed to determine the step size (spacing of points)
img_wwidth of the image
img_hheight of the image
subset_file_infoOptional information from the subset file (ROIs, etc.)
pointerto an image to use for checking SSSIG
grad_thresholdsubsets with a gradiend SSSIG lower than this will be removed

◆ create_synthetic_speckle_image()

Teuchos::RCP<Image> DICe::create_synthetic_speckle_image ( const int_t  w,
const int_t  h,
const int_t  offset_x,
const int_t  offset_y,
const scalar_t speckle_size,
const Teuchos::RCP< Teuchos::ParameterList > &  params = Teuchos::null 
)

free function to create a synthetically speckled image with perfectly smooth and regular speckles of a certain size

Parameters
wwidth of the image
hheight of the image
offset_xthe x offset for a sub image
offset_ythe y offset for a sub image
speckle_sizesize of the speckles to create
paramsset of image parameters (compute gradients, etc)

◆ cross()

DICE_LIB_DLL_EXPORT scalar_t DICe::cross ( const scalar_t A,
const scalar_t B,
const scalar_t C 
)

compute the cross product of two vectors (ABxAC) and return the area of the parallelogram

Parameters
Avector to point A
Bvector to point B
Cvector to point C

◆ cross3d()

DICE_LIB_DLL_EXPORT scalar_t DICe::cross3d ( const scalar_t A,
const scalar_t B,
const scalar_t C 
)

compute the cross product of two vectors (ABxAC) in 3d

Parameters
Avector to point A
Bvector to point B
Cvector to point C

◆ cross3d_with_cross_prod()

DICE_LIB_DLL_EXPORT void DICe::cross3d_with_cross_prod ( const scalar_t A,
const scalar_t B,
const scalar_t C,
scalar_t cross_prod 
)

compute the cross product of two vectors (ABxAC) and return the area of the parallelogram also output the cross-product of the two

Parameters
Avector to point A
Bvector to point B
Cvector to point C
cross_prod[out] the vector ABXAC (not normalized by the mag as the normal would be)

◆ cross3d_with_normal()

DICE_LIB_DLL_EXPORT scalar_t DICe::cross3d_with_normal ( const scalar_t A,
const scalar_t B,
const scalar_t C,
scalar_t normal 
)

compute the cross product of two vectors (ABxAC) and return the area of the parallelogram also output the normal of the two

Parameters
Avector to point A
Bvector to point B
Cvector to point C
normal[out] the vector normal to ABXAC

◆ decipher_image_file_names()

DICE_LIB_DLL_EXPORT void DICe::decipher_image_file_names ( Teuchos::RCP< Teuchos::ParameterList >  params,
std::vector< std::string > &  image_files,
std::vector< std::string > &  stero_image_files,
int_t frame_id_start,
int_t num_frames,
int_t frame_skip 
)

Converts params into string names of all the images in a sequence.

Parameters
paramsDefines the prefix for the image names, number of images, etc.
image_files[out] list of 2d image files or left camera files
stereo_image_files[out] list of stereo image files or right camera (size 0 for 2d)

◆ determinant_4x4()

DICE_LIB_DLL_EXPORT scalar_t DICe::determinant_4x4 ( const scalar_t a)

Compute the determinant of a 4 x 4

Parameters
aThe coefficients in an array format

◆ dice_default_params()

DICE_LIB_DLL_EXPORT void DICe::dice_default_params ( Teuchos::ParameterList *  defaultParams)

Sets the default correlation parameters.

Parameters
defaultParamsreturned ParameterList with the default params set

◆ finalize_xml_file()

void DICe::finalize_xml_file ( const std::string &  file_name)

Create the closing parameter syntax.

Parameters
file_nameThe name of the xml file

◆ frame_should_be_skipped()

bool DICe::frame_should_be_skipped ( const int_t  trigger_based_frame_index,
std::vector< int_t > &  frame_id_vector 
)

free function given a std::vector to determine if a frame index should be skipped or not

Parameters
trigger_based_frame_indexindex of the frame (as referenced to the trigger frame, can be negative)
frame_id_vectorvector of ids to turn skip solve off and on (first id is where the skipping should begin evey id after that changes the state of skipping. For example, if values 0 10 23 56 are stored in frame id vector skipping the solves begins on frame 0, then solves are done from 10 to 23, frames from 23 to 56 will have the solve skipped and solving will be performed for all frames after 56.

◆ gauss_1D()

DICE_LIB_DLL_EXPORT void DICe::gauss_1D ( Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &  r,
Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &  w,
int_t  gauss_order 
)

Compute the 1d gauss points

Parameters
rthe gauss points
wthe wieghts
gauss_orderthe order of integration

◆ gauss_2D()

DICE_LIB_DLL_EXPORT void DICe::gauss_2D ( Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &  r,
Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &  w,
int_t  gauss_order 
)

Compute the 2d gauss points

Parameters
rthe gauss points
wthe wieghts
gauss_orderthe order of integration

◆ generate_template_input_files()

DICE_LIB_DLL_EXPORT void DICe::generate_template_input_files ( const std::string &  file_prefix)

Create template input files with lots of comments.

Parameters
file_prefixThe prefix used to name the template files

◆ image_fft() [1/2]

DICE_LIB_DLL_EXPORT Teuchos::RCP<Image> DICe::image_fft ( Teuchos::RCP< Image image,
const bool  hamming_filter = true,
const bool  apply_log = true,
const scalar_t  scale_factor = 100.0,
bool  shift = true,
const bool  high_pass_filter = false 
)

compute the image fft and return an image with intensity values as the magnitude of the FFT values note: the fft values are scaled and the log is taken, so taking the inverse fft of an fft image is not the original image

Parameters
imagethe image to take the FFT of
hamming_filtertrue if a hamming filter should be applied to the image
apply_logtrue if the log of the values should be taken
scale_factorused if the log is applied i = scale_factor*log(i+1)
shifttrue if the quandrants of the fft image should be swapped
high_pass_filtertrue if the values should be filtered

◆ image_fft() [2/2]

DICE_LIB_DLL_EXPORT void DICe::image_fft ( Teuchos::RCP< Image image,
Teuchos::ArrayRCP< scalar_t > &  real,
Teuchos::ArrayRCP< scalar_t > &  complex,
const int_t  inverse = 0,
const bool  hamming_filter = true 
)

FFT of an image

Parameters
imagethe image to take the FFT of
real[out] the real part of the FFT
complex[out] the imaginary part of the FFT
inverse1 if this should be an inverse FFT (back to time domain)
hamming_filtertrue if a hamming filter should be applied to the image

◆ initialize()

void DICe::initialize ( int  argc,
char *  argv[] 
)

Initialization function (mpi and kokkos if enabled):

Parameters
argcargument count
argvarray of argument chars

◆ initialize_xml_file()

void DICe::initialize_xml_file ( const std::string &  file_name)

Create the opening parameter syntax.

Parameters
file_nameThe name of the xml file

◆ is_number()

DICE_LIB_DLL_EXPORT bool DICe::is_number ( const std::string &  s)

Determines if a string is a number.

Parameters
sInput string

◆ kronecker()

DICE_LIB_DLL_EXPORT Teuchos::ArrayRCP<Teuchos::ArrayRCP<scalar_t> > DICe::kronecker ( Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &  A,
Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &  B 
)

Compute the kronecker product of two matrices

Parameters
Athe A matrix
Bthe B matrix

◆ operator<()

bool DICe::operator< ( const def_triad lhs,
const def_triad rhs 
)
inline

operator < overload for inserting values in a set

Parameters
lhsleft hand side def_triad
rhsright hand side def_triad

◆ operator==()

bool DICe::operator== ( const def_triad lhs,
const def_triad rhs 
)
inline

operator == overload for inserting values in a set

Parameters
lhsleft hand side def_triad
rhsright hand side def_triad

◆ parse_command_line()

DICE_LIB_DLL_EXPORT Teuchos::RCP<Teuchos::ParameterList> DICe::parse_command_line ( int  argc,
char *  argv[],
bool &  force_exit,
Teuchos::RCP< std::ostream > &  outStream 
)

Parses the options set in the command line when dice is invoked.

Parameters
argctypical argument from main
argvtypical argument from main
force_exittrue if the executable should exit gracefully
outStream[out] The output stream, gets set to cout or blackholeStream depending on command line options

◆ phase_correlate_row()

DICE_LIB_DLL_EXPORT void DICe::phase_correlate_row ( Teuchos::RCP< Image image_a,
Teuchos::RCP< Image image_b,
const int_t  row_id,
scalar_t u,
const bool  convert_to_theta = false 
)

Phase correlate a single row from two images

Parameters
image_athe first image
image_bthe second image
row_idthe id of the row to correlate
uthe output displacement
convert_to_thetaconver the displacement to degrees

◆ phase_correlate_x_y()

DICE_LIB_DLL_EXPORT scalar_t DICe::phase_correlate_x_y ( Teuchos::RCP< Image image_a,
Teuchos::RCP< Image image_b,
scalar_t u_x,
scalar_t u_y,
const bool  convert_to_r_theta = false 
)

Phase correlate two images, If the images have been polar transformed, then set the convert_to_r_theta flag to true, in that case theta is positive counter-clockwise the return value is the peak magnitude value from the fft cross-correlation

Parameters
image_athe left image to correlate
image_bthe right image to correlate
u_x[out] displacement x
u_y[out] displacement y
convert_to_r_thetatrue if the images are polar transforms and the correlation is for radius and angle of rotation

◆ polar_transform()

DICE_LIB_DLL_EXPORT Teuchos::RCP<Image> DICe::polar_transform ( Teuchos::RCP< Image image,
const bool  high_pass_filter = false 
)

2D polar transformation of an image returns a new image that is the polar transform of the input image

Parameters
imagethe input image
high_pass_filtertrue if the radius of the polar transform should be limited to w/4 since the rest of the image would be zero from filtering so the output image will be twice as tall as the input

◆ read_circle()

DICE_LIB_DLL_EXPORT Teuchos::RCP<DICe::Circle> DICe::read_circle ( std::fstream &  dataFile)

Read a circle from the input file.

Parameters
dataFilefstream file to read line from (assumed to be open)

◆ read_correlation_params()

DICE_LIB_DLL_EXPORT Teuchos::RCP<Teuchos::ParameterList> DICe::read_correlation_params ( const std::string &  paramFileName)

Read the correlation parameters from a file.

Parameters
paramFileNameFile name of the correlation parameters file

◆ read_input_params()

DICE_LIB_DLL_EXPORT Teuchos::RCP<Teuchos::ParameterList> DICe::read_input_params ( const std::string &  paramFileName)

Read the input parameters from a file.

Parameters
paramFileNameFile name of the input parameters file

◆ read_polygon()

DICE_LIB_DLL_EXPORT Teuchos::RCP<DICe::Polygon> DICe::read_polygon ( std::fstream &  dataFile)

Read a polygon from the input file.

Parameters
dataFilefstream file to read line from (assumed to be open)

◆ read_rectangle()

DICE_LIB_DLL_EXPORT Teuchos::RCP<DICe::Rectangle> DICe::read_rectangle ( std::fstream &  dataFile)

Read a circle from the input file.

Parameters
dataFilefstream file to read line from (assumed to be open)

◆ read_shapes()

DICE_LIB_DLL_EXPORT multi_shape DICe::read_shapes ( std::fstream &  dataFile)

Read Several shapes from the subset file.

Parameters
dataFilefstream file to read line from (assumed to be open)

◆ read_subset_file()

const DICE_LIB_DLL_EXPORT Teuchos::RCP<Subset_File_Info> DICe::read_subset_file ( const std::string &  fileName,
const int_t  width = -1,
const int_t  height = -1 
)

Read a list of coordinates for correlation points from file.

Parameters
fileNameString name of the file that defines the subsets
widthThe image width (used to check for valid coords)
heightThe image height (used to check for valid coords) TODO add conformal subset notes here.

◆ safeGetline()

DICE_LIB_DLL_EXPORT std::istream& DICe::safeGetline ( std::istream &  is,
std::string &  t 
)

safe getline that works with windows and linux line endings

Parameters
isinput stream
t[out] string from getline

◆ shape_function_factory()

Teuchos::RCP<Local_Shape_Function> DICe::shape_function_factory ( Schema *  schema = NULL)

factory to create the right shape function

Parameters
schemapointer to a schema to use to initialize the shape function

◆ string_to_entity_rank()

field_enums::Entity_Rank DICe::string_to_entity_rank ( const std::string &  input_string)

converts a string to entity rank

Parameters
input_stringthe input string

◆ string_to_field_name()

field_enums::Field_Name DICe::string_to_field_name ( const std::string &  input_string)

converts a string to a field name

Parameters
input_stringthe input string

◆ string_to_field_type()

field_enums::Field_Type DICe::string_to_field_type ( const std::string &  input_string)

converts a string to a field type

Parameters
input_stringthe input string

◆ tokenize_line()

DICE_LIB_DLL_EXPORT std::vector<std::string> DICe::tokenize_line ( std::istream &  dataFile,
const std::string &  delim = " \t",
const bool  capitalize = true 
)

Turns a string read from getline() into tokens.

Parameters
dataFilefstream file to read line from (assumed to be open)
delimDelimiter character
capitalizetrue if the tokens should be automatically capitalized

◆ tostring() [1/3]

std::string DICe::tostring ( const field_enums::Entity_Rank field_rank)

converts a field rank to string

Parameters
field_rankthe field rank

◆ tostring() [2/3]

std::string DICe::tostring ( const field_enums::Field_Name field_name)

converts a field name to a string

Parameters
field_namethe field name

◆ tostring() [3/3]

std::string DICe::tostring ( const field_enums::Field_Type field_type)

converts a field type to string

Parameters
field_typethe field type

◆ tracking_default_params()

DICE_LIB_DLL_EXPORT void DICe::tracking_default_params ( Teuchos::ParameterList *  defaultParams)

Returns a pointer to a ParameterList with default params specified.

Parameters
defaultParamsPointer to the ParameterList to be returned

A free function like this is used to prevent having to re-code the defaults everywhere they are used.

◆ tri2d_natural_integration_points()

DICE_LIB_DLL_EXPORT void DICe::tri2d_natural_integration_points ( const int_t  order,
Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &  locations,
Teuchos::ArrayRCP< scalar_t > &  weights,
int_t num_points 
)

gather the natural integration points for a triangle

Parameters
orderthe integration order
locationsarray returned with integration point locations
weightsarray returned with the weights associated with each point
num_pointsreturn value with the total number of integration points

◆ tri2d_nonexact_integration_points()

DICE_LIB_DLL_EXPORT void DICe::tri2d_nonexact_integration_points ( const int_t  order,
Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &  locations,
Teuchos::ArrayRCP< scalar_t > &  weights,
int_t num_points 
)

gather the natural integration points for a triangle these points are equally spaced and weighted so this isn't exact for any order

Parameters
orderthe integration order
locationsarray returned with integration point locations
weightsarray returned with the weights associated with each point
num_pointsreturn value with the total number of integration points

◆ tri3d_natural_integration_points()

DICE_LIB_DLL_EXPORT void DICe::tri3d_natural_integration_points ( const int_t  order,
Teuchos::ArrayRCP< Teuchos::ArrayRCP< scalar_t > > &  locations,
Teuchos::ArrayRCP< scalar_t > &  weights,
int_t num_points 
)

gather the natural integration points for a triangle

Parameters
orderthe integration order
locationsarray returned with integration point locations
weightsarray returned with the weights associated with each point
num_pointsreturn value with the total number of integration points

◆ update_field_names()

void DICe::update_field_names ( const field_enums::Field_Name field_name,
const std::string &  input_string 
)

updates the field names by adding the given field to the list

Parameters
field_namethe name of the field to add
input_stringthe string name of the field

◆ valid_correlation_point()

DICE_LIB_DLL_EXPORT bool DICe::valid_correlation_point ( const int_t  x_coord,
const int_t  y_coord,
const int_t  subset_size,
const int_t  img_w,
const int_t  img_h,
std::set< std::pair< int_t, int_t > > &  coords,
std::set< std::pair< int_t, int_t > > &  excluded_coords,
Teuchos::RCP< DICe::Image image = Teuchos::null,
const scalar_t grad_threshold = 0.0 
)

Test to see that the point falls with the boundary of a conformal def and not in the excluded area.

Parameters
x_coordX coordinate of the point in question
y_coordY coordinate of the point in question
subset_sizeSize of the subset
img_wwidth of the image
img_hheight of the image
coordsSet of valid coordinates in the area
excluded_coordsSet of coordinates that should be excluded
pointerto an image to use for checking SSSIG
grad_thresholdthe SSSIG threshold to eliminate a subset without enough gradients to correlate

◆ write_xml_bool_literal_param()

void DICe::write_xml_bool_literal_param ( const std::string &  file_name,
const std::string &  name,
const bool  value = true,
const bool  commented = true 
)

Write a boolean valued parameter to file.

Parameters
file_nameThe name of the xml file to write to
nameThe name of the parameter
valueThe bool value of the parameter
commentedDetermines if this parameter should be commented out

◆ write_xml_bool_param() [1/2]

void DICe::write_xml_bool_param ( const std::string &  file_name,
const std::string &  name,
const bool  value 
)

Write a boolean valued parameter to file.

Parameters
file_nameThe name of the xml file to write to
nameThe name of the parameter
valueThe string value of the parameter

◆ write_xml_bool_param() [2/2]

void DICe::write_xml_bool_param ( const std::string &  file_name,
const std::string &  name,
const std::string &  value = "<value>",
const bool  commented = true 
)

Write a boolean valued parameter to file.

Parameters
file_nameThe name of the xml file to write to
nameThe name of the parameter
valueThe string value of the parameter
commentedDetermines if this parameter should be commented out

◆ write_xml_comment()

void DICe::write_xml_comment ( const std::string &  file_name,
const std::string &  comment 
)

Write a comment to the xml file specified.

Parameters
file_nameThe name of the xml file
commentString comment to print to file

◆ write_xml_file()

void DICe::write_xml_file ( const std::string &  file_name,
const Teuchos::ParameterList &  params 
)

write an xml file based on a teuchos parameter list

Parameters
file_namethe name of the output file
paramsthe Teuchos::ParameterList

◆ write_xml_high_precision_real_param()

void DICe::write_xml_high_precision_real_param ( const std::string &  file_name,
const std::string &  name,
const double &  value 
)

Write a high precision real valued parameter to file.

Parameters
file_nameThe name of the xml file to write to
nameThe name of the parameter
valueThe string value of the parameter

◆ write_xml_param()

void DICe::write_xml_param ( const std::string &  file_name,
const std::string &  name,
const std::string &  type,
const std::string &  value,
const bool  commented = true 
)

Write a general xml parameter to file.

Parameters
file_nameThe name of the xml file to write to
nameThe name of the parameter
typeThe type of the parameter (bool, int, double, string)
valueThe string value of the parameter
commentedDetermines if this parameter should be commented out

◆ write_xml_param_list_close()

void DICe::write_xml_param_list_close ( const std::string &  file_name,
const bool  commented = true 
)

Write the closing part of a ParameterList.

Parameters
file_nameThe xml file
commentedString comment to print to file

◆ write_xml_param_list_open()

void DICe::write_xml_param_list_open ( const std::string &  file_name,
const std::string &  name,
const bool  commented = true 
)

Write the opening part of a ParameterList.

Parameters
file_nameThe xml file
nameName of the ParameterList
commentedString comment to print to file

◆ write_xml_real_param() [1/2]

void DICe::write_xml_real_param ( const std::string &  file_name,
const std::string &  name,
const double &  value 
)

Write a real valued parameter to file.

Parameters
file_nameThe name of the xml file to write to
nameThe name of the parameter
valueThe string value of the parameter

◆ write_xml_real_param() [2/2]

void DICe::write_xml_real_param ( const std::string &  file_name,
const std::string &  name,
const std::string &  value = "<value>",
const bool  commented = true 
)

Write a real valued parameter to file.

Parameters
file_nameThe name of the xml file to write to
nameThe name of the parameter
valueThe string value of the parameter
commentedDetermines if this parameter should be commented out

◆ write_xml_size_param() [1/2]

void DICe::write_xml_size_param ( const std::string &  file_name,
const std::string &  name,
const int  value 
)

Write an integer valued parameter to file.

Parameters
file_nameThe name of the xml file to write to
nameThe name of the parameter
valueThe string value of the parameter

◆ write_xml_size_param() [2/2]

void DICe::write_xml_size_param ( const std::string &  file_name,
const std::string &  name,
const std::string &  value = "<value>",
const bool  commented = true 
)

Write an integer valued parameter to file.

Parameters
file_nameThe name of the xml file to write to
nameThe name of the parameter
valueThe string value of the parameter
commentedDetermines if this parameter should be commented out

◆ write_xml_string_param()

void DICe::write_xml_string_param ( const std::string &  file_name,
const std::string &  name,
const std::string &  value = "<value>",
const bool  commented = true 
)

Write a string parameter to file.

Parameters
file_nameThe name of the xml file to write to
nameThe name of the parameter
valueThe string value of the parameter
commentedDetermines if this parameter should be commented out