Isis 3 Programmer Reference
|
Gruen (adaptive) pattern matching. More...
#include <AdaptiveGruen.h>
Public Types | |
enum | RegisterStatus { SuccessPixel, SuccessSubPixel, PatternChipNotEnoughValidData, FitChipNoData, FitChipToleranceNotMet, SurfaceModelNotEnoughValidData, SurfaceModelSolutionInvalid, SurfaceModelDistanceInvalid, PatternZScoreNotMet, AdaptiveAlgorithmFailed } |
Enumeration of the Register() method's return status. More... | |
enum | GradientFilterType { None, Sobel } |
Enumeration of the different types of gradient filters that can be applied to the pattern and search chips before matching them. More... | |
Public Member Functions | |
AdaptiveGruen (Pvl &pvl) | |
Construct a AdaptiveGruen search algorithm. More... | |
virtual | ~AdaptiveGruen () |
Destructor for AdaptiveGruen. More... | |
virtual bool | IsAdaptive () |
AdaptiveGruen is adaptive. More... | |
BigInt | CallCount () const |
Returns the current call count. More... | |
void | WriteSubsearchChips (const QString &pattern="SubChip") |
Set up for writing subsearch for a a given registration call. More... | |
AffineTolerance | getAffineTolerance () const |
Return set of tolerances for affine convergence. More... | |
double | getSpiceConstraint () const |
Returns the SPICE tolerance constraint as read from config file. More... | |
double | getAffineConstraint () const |
Returns the Affine tolerance constraint as read from config file. More... | |
void | setAffineRadio (const AffineRadio &affrad) |
Sets initial chip transformation. More... | |
void | setAffineRadio () |
Set affine parameters to defaults. More... | |
const AffineRadio & | getDefaultAffineRadio () const |
Returns default settings for Affine/Radiometric parameters. More... | |
const AffineRadio & | getAffineRadio () const |
Return current state of Affine/Radio state More... | |
MatchPoint | getLastMatch () const |
Returns the register state of the last successful Gruen match. More... | |
Chip * | PatternChip () |
Return pointer to pattern chip. More... | |
Chip * | SearchChip () |
Return pointer to search chip. More... | |
Chip * | FitChip () |
Return pointer to fit chip. More... | |
Chip * | RegistrationPatternChip () |
Return pointer to pattern chip used in registration. More... | |
Chip * | RegistrationSearchChip () |
Return pointer to search chip used in registration. More... | |
Chip * | ReducedPatternChip () |
Return pointer to reduced pattern chip. More... | |
Chip * | ReducedSearchChip () |
Return pointer to reduced search chip. More... | |
Chip * | ReducedFitChip () |
Return pointer to reduced fit chip. More... | |
void | SetSubPixelAccuracy (bool on) |
If the sub-pixel accuracy is enabled, the Register() method will attempt to match the pattern chip to the search chip at sub-pixel accuracy, otherwise it will be registered at whole pixel accuracy. More... | |
void | SetPatternValidPercent (const double percent) |
Set the amount of data in the pattern chip that must be valid. More... | |
void | SetSubsearchValidPercent (const double percent) |
Set the amount of data in the search chip's subchip that must be valid. More... | |
void | SetTolerance (double tolerance) |
Set the tolerance for an acceptable goodness of fit. More... | |
void | SetChipInterpolator (const QString &interpolator) |
Sets the Chip class interpolator type to be used to load pattern and search chips. More... | |
void | SetSurfaceModelWindowSize (int size) |
Set the surface model window size. More... | |
void | SetSurfaceModelDistanceTolerance (double distance) |
Set a distance the surface model solution is allowed to move away from the best whole pixel fit in the fit chip. More... | |
void | SetReductionFactor (int reductionFactor) |
Set the reduction factor used to speed up the pattern matching algorithm. More... | |
void | SetPatternZScoreMinimum (double minimum) |
Set the minimum pattern zscore. More... | |
void | SetGradientFilterType (const QString &gradientFilterType) |
Set the gradient filter type to be applied to the search and pattern chips. More... | |
QString | GradientFilterString () const |
bool | SubPixelAccuracy () |
Return whether this object will attempt to register to whole or sub-pixel accuracy. More... | |
int | ReductionFactor () |
Return the reduction factor. More... | |
double | PatternValidPercent () const |
Return pattern chip valid percent. The default value is. More... | |
double | SubsearchValidPercent () const |
Return subsearch chip valid percent. More... | |
double | Tolerance () const |
Return match algorithm tolerance. More... | |
double | WindowSize () const |
Return window size. More... | |
double | DistanceTolerance () const |
Return distance tolerance. More... | |
void | Distance (double &sampDistance, double &lineDistance) |
Return the distance point moved. More... | |
AutoReg::RegisterStatus | Register () |
Walk the pattern chip through the search chip to find the best registration. More... | |
bool | Success () const |
Return whether the match algorithm succeeded or not. More... | |
double | GoodnessOfFit () const |
Return the goodness of fit of the match algorithm. More... | |
bool | IsIdeal (double fit) |
Returns true if the fit parameter is arbitrarily close to the ideal fit value. More... | |
double | ChipSample () const |
Return the search chip sample that best matched. More... | |
double | ChipLine () const |
Return the search chip line that best matched. More... | |
double | CubeSample () const |
Return the search chip cube sample that best matched. More... | |
double | CubeLine () const |
Return the search chip cube line that best matched. More... | |
double | MinimumZScore () const |
Return minimumPatternZScore. More... | |
void | ZScores (double &score1, double &score2) const |
Return the ZScores of the pattern chip. More... | |
Pvl | RegistrationStatistics () |
This returns the cumulative registration statistics. More... | |
virtual double | MostLenientTolerance () |
Minimum tolerance specific to algorithm. More... | |
PvlGroup | RegTemplate () |
This function returns the keywords that this object was created from. More... | |
PvlGroup | UpdatedTemplate () |
Returns a PvlGroup containing the PvlKeywords of the parameters this object was most recently run with. More... | |
Protected Member Functions | |
virtual QString | AlgorithmName () const |
Return name of Algorithm. More... | |
int | algorithm (Chip &pattern, Chip &subsearch, const Radiometric &radio, BigInt &ptsUsed, double &resid, GMatrix &atai, AffineRadio &affrad) |
Real workhorse of the computational Gruen algorithm. More... | |
Analysis | errorAnalysis (const BigInt &npts, const double &resid, const GMatrix &atai) |
Compute the error analysis of convergent Gruen matrix. More... | |
virtual double | MatchAlgorithm (Chip &pattern, Chip &subsearch) |
Minimization of data set using Gruen algorithm. More... | |
virtual bool | CompareFits (double fit1, double fit2) |
This virtual method must return if the 1st fit is equal to or better than the second fit. More... | |
virtual double | IdealFit () const |
Returns the ideal fit for a perfect Gruen result. More... | |
virtual AutoReg::RegisterStatus | Registration (Chip &sChip, Chip &pChip, Chip &fChip, int startSamp, int startLine, int endSamp, int endLine, int bestSamp, int bestLine) |
Applies the adaptive Gruen algorithm to pattern and search chips. More... | |
virtual Pvl | AlgorithmStatistics (Pvl &pvl) |
Create Gruen error and processing statistics Pvl output. More... | |
void | SetChipSample (double sample) |
Sets the search chip subpixel sample that matches the pattern tack sample. More... | |
void | SetChipLine (double line) |
Sets the search chip subpixel line that matches the pattern tack line. More... | |
void | SetGoodnessOfFit (double fit) |
Sets the goodness of fit for adaptive algorithms. More... | |
void | Parse (Pvl &pvl) |
Initialize parameters in the AutoReg class using a PVL specification. More... | |
bool | SetSubpixelPosition (Chip &window) |
Set the search chip sample and line to subpixel values if possible. More... | |
Chip | Reduce (Chip &chip, int reductionFactor) |
This method reduces the given chip by the given reduction factor. More... | |
Protected Attributes | |
PvlObject | p_template |
AutoRegistration object that created this projection. More... | |
Private Types | |
enum | ErrorTypes { NotEnoughPoints = 1, CholeskyFailed = 2, EigenSolutionFailed = 3, AffineNotInvertable = 4, MaxIterationsExceeded = 5, RadShiftExceeded = 6, RadGainExceeded = 7, MaxEigenExceeded = 8, AffineDistExceeded = 9 } |
Error enumeration values. More... | |
typedef CollectorMap< int, ErrorCounter > | ErrorList |
Declaration of error count list. More... | |
Private Member Functions | |
QString | ConfKey (const DbProfile &conf, const QString &keyname, const QString &defval, int index=0) const |
Helper method to initialize parameters. More... | |
template<typename T > | |
T | ConfKey (const DbProfile &conf, const QString &keyname, const T &defval, int index=0) const |
Helper method to initialize parameters. More... | |
template<typename T > | |
PvlKeyword | ParameterKey (const QString &keyname, const T &value, const QString &unit="") const |
Keyword formatter for Gruen parameters. More... | |
PvlKeyword | ValidateKey (const QString keyname, const double &value, const QString &unit="") const |
Checks value of key, produces appropriate value. More... | |
ErrorList | initErrorList () const |
Creates an error list from know Gruen errors. More... | |
int | logError (int gerrno, const QString &gerrmsg) |
Logs a Gruen error. More... | |
PvlGroup | StatsLog () const |
Create a PvlGroup with the Gruen specific statistics. More... | |
PvlGroup | ParameterLog () const |
Create a PvlGroup with the Gruen specific parameters. More... | |
void | init (Pvl &pvl) |
Initialize the object. More... | |
Radiometric | getDefaultRadio () const |
Returns the default radiometric gain value. More... | |
double | DegreesOfFreedom (const int npts) const |
Returns number of degrees of freedom of points. More... | |
void | resetStats () |
Reset Gruen statistics as needed. More... | |
GMatrix | Identity (const int &ndiag=3) const |
GMatrix | Choldc (const GMatrix &a, GVector &p) const |
Compute Cholesky solution. More... | |
GMatrix | Cholsl (const GMatrix &a, const GVector &p, const GMatrix &b, const GMatrix &x) const |
Compute Cholesky solution matrix from correlation. More... | |
int | Jacobi (const GMatrix &a, GVector &evals, GMatrix &evecs, const int &MaxIters=50) const |
Compute the Jacobian of a covariance matrix. More... | |
void | EigenSort (GVector &evals, GMatrix &evecs) const |
Sort eigenvectors from highest to lowest. More... | |
BigInt | MinValidPoints (BigInt totalPoints) const |
Computes the number of minimum valid points. More... | |
bool | ValidPoints (BigInt totalPoints, BigInt nPoints) const |
Determines if number of points is valid percentage of all points. More... | |
int | CheckConstraints (MatchPoint &point) |
Test user limits/contraints after the algorithm has converged. More... | |
Coordinate | getChipUpdate (Chip &sChip, MatchPoint &point) const |
Compute the chip coordinate of the registered pixel. More... | |
AutoReg::RegisterStatus | Status (const MatchPoint &result) |
Returns the proper status given a Gruen result container. More... | |
void | Match (Chip &sChip, Chip &pChip, Chip &fChip, int startSamp, int endSamp, int startLine, int endLine) |
Empty copy constructor. More... | |
bool | ComputeChipZScore (Chip &chip) |
This method computes the given Chip's Z-Score. More... | |
void | Init () |
Initialize AutoReg object private variables. More... | |
void | ApplyGradientFilter (Chip &chip) |
Run a gradient filter over the chip. More... | |
void | SobelGradient (Buffer &in, double &v) |
Compute a Sobel gradient based on an input buffer. More... | |
Static Private Member Functions | |
static Pvl & | getDefaultParameters () |
Load default Gruen parameter file in $ISISROOT/appdata/templates. More... | |
Private Attributes | |
BigInt | m_callCount |
QString | m_filePattern |
ErrorList | m_errors |
BigInt | m_unclassified |
int | m_maxIters |
int | m_nIters |
BigInt | m_totalIterations |
DbProfile | m_prof |
double | m_transTol |
double | m_scaleTol |
double | m_shearTol |
double | m_spiceTol |
double | m_affineTol |
double | m_shiftTol |
double | m_rgainMinTol |
double | m_rgainMaxTol |
double | m_defGain |
double | m_defShift |
AffineRadio | m_defAffine |
AffineRadio | m_affine |
MatchPoint | m_point |
Statistics | m_eigenStat |
Statistics | m_iterStat |
Statistics | m_shiftStat |
Statistics | m_gainStat |
Chip | p_patternChip |
Chip to be matched. More... | |
Chip | p_searchChip |
Chip to be searched for best registration. More... | |
Chip | p_fitChip |
Results from MatchAlgorithm() method. More... | |
Chip | p_gradientSearchChip |
Chip to be searched for best registration with gradient applied. More... | |
Chip | p_gradientPatternChip |
Chip to be matched with gradient applied. More... | |
Chip | p_reducedPatternChip |
Pattern Chip with reduction factor. More... | |
Chip | p_reducedSearchChip |
Search Chip with reduction factor. More... | |
Chip | p_reducedFitChip |
Fit Chip with reduction factor. More... | |
bool | p_subpixelAccuracy |
Indicates whether sub-pixel accuracy is enabled. Default is true. More... | |
int | p_totalRegistrations |
Registration Statistics Total keyword. More... | |
int | p_pixelSuccesses |
Registration statistics Success keyword. More... | |
int | p_subpixelSuccesses |
Registration statistics Success keyword. More... | |
int | p_patternChipNotEnoughValidDataCount |
Registration statistics PatternNotEnoughValidData keyword. More... | |
int | p_patternZScoreNotMetCount |
Registration statistics PatternZScoreNotMet keyword. More... | |
int | p_fitChipNoDataCount |
Registration statistics FitChipNoData keyword. More... | |
int | p_fitChipToleranceNotMetCount |
Registration statistics FitChipToleranceNotMet keyword. More... | |
int | p_surfaceModelNotEnoughValidDataCount |
Registration statistics SurfaceModelNotEnoughValidData keyword. More... | |
int | p_surfaceModelSolutionInvalidCount |
Registration statistics SurfaceModelSolutionInvalid keyword. More... | |
int | p_surfaceModelDistanceInvalidCount |
Registration statistics SurfaceModelDistanceInvalid keyword. More... | |
double | p_zScoreMin |
First Z-Score of pattern chip. More... | |
double | p_zScoreMax |
Second Z-Score of pattern chip. More... | |
double | p_minimumPatternZScore |
Minimum pattern Z-Score. More... | |
double | p_patternValidPercent |
Percentage of data in pattern chip that must be valid. More... | |
double | p_subsearchValidPercent |
Percentage of data in subsearch chip that must be valid. More... | |
double | p_chipSample |
Chip sample. More... | |
double | p_chipLine |
Chip line. More... | |
double | p_cubeSample |
Cube sample. More... | |
double | p_cubeLine |
Cube line. More... | |
double | p_goodnessOfFit |
Goodness of fit of the match algorithm. More... | |
double | p_tolerance |
Tolerance for acceptable goodness of fit in match algorithm. More... | |
int | p_windowSize |
Surface model window size. More... | |
double | p_distanceTolerance |
Maximum distance the surface model solution may be from the best whole pixel fit in the fit chip. More... | |
double | p_bestFit |
Goodness of fit for adaptive algorithms. More... | |
int | p_bestSamp |
Sample value of best fit. More... | |
int | p_bestLine |
Line value of best fit. More... | |
double | p_sampMovement |
The number of samples the point moved. More... | |
double | p_lineMovement |
The number of lines the point moved. More... | |
int | p_reduceFactor |
Reduction factor. More... | |
Isis::AutoReg::RegisterStatus | p_registrationStatus |
Registration status to be returned by Register(). More... | |
AutoReg::GradientFilterType | p_gradientFilterType |
Type of gradient filter to use before matching. More... | |
Gruen (adaptive) pattern matching.
The AdaptiveGruen pattern/search chip registration algorithm is derived from the Gruen class. It is adaptive in that it uses an Affine transform to load the subsearch chip from the search chip. The Affine transform is iteratively minimized to converge on an cummulative affine solution that best matches the pattern chip.
Definition at line 35 of file AdaptiveGruen.h.
|
privateinherited |
|
privateinherited |
|
inherited |
|
inherited |
Enumeration of the Register() method's return status.
All of the enumerations describe a failure to register except "Success". These status values can be used to provide the user with more specific feedback on why registration did not succeed.
|
inline |
Construct a AdaptiveGruen search algorithm.
This will construct an AdaptiveGruen search algorithm. It is recommended that you use a AutoRegFactory class as opposed to this constructor
pvl | A Pvl object that contains a valid automatic registration definition |
Definition at line 47 of file AdaptiveGruen.h.
|
inlinevirtual |
Destructor for AdaptiveGruen.
Definition at line 50 of file AdaptiveGruen.h.
|
protectedinherited |
Real workhorse of the computational Gruen algorithm.
This method is called for all registration requests and actually performs the registration of two chips.
The pattern chip is deemed constant. The subsearch chip is generally an extraction from the search chip that has had an affine transform applied to fill it.
At each iteration of the Gruen algorithm, the affine transform is incrementally updated based upon the results from this method. There are six affine parameters and two radiometric (shift and gain) parameters that are solved/computed here.
The algorithm itself is a first derivative computation of the subsearch chip with small radiometric adjustments applied to better tone match the two chips. This is intended to minimize the affine variability.
pattern | Fixed pattern chip which subsearch is trying to match |
subsearch | Affined extraction of the search chip |
Definition at line 156 of file Gruen.cpp.
References Isis::Gruen::Choldc(), Isis::Gruen::Cholsl(), Isis::Chip::GetValue(), Isis::Chip::IsValid(), Isis::Chip::Lines(), Isis::Gruen::logError(), Isis::Gruen::MinValidPoints(), Isis::Chip::Samples(), Isis::Chip::TackLine(), Isis::Chip::TackSample(), Isis::IException::toString(), and Isis::Gruen::ValidPoints().
Referenced by Isis::Gruen::MatchAlgorithm(), and Isis::Gruen::Registration().
|
inlineprotectedvirtual |
Return name of Algorithm.
Reimplemented from Isis::Gruen.
Definition at line 67 of file AdaptiveGruen.h.
Create Gruen error and processing statistics Pvl output.
This method generates two groups specific to the Gruen algorithm: The GruenFailures group which logs all the errors enountered during processing and the GruenStatistics group which logs selected statistics gathered during a registration run.
These groups are added to the AutoReg log output Pvl container for reporting to user/log files.
Reimplemented from Isis::AutoReg.
Definition at line 824 of file Gruen.cpp.
References Isis::PvlObject::addGroup(), Isis::Gruen::AlgorithmName(), Isis::CollectorMap< K, T, ComparePolicy, RemovalPolicy, CopyPolicy >::getNth(), Isis::Gruen::ParameterLog(), Isis::CollectorMap< K, T, ComparePolicy, RemovalPolicy, CopyPolicy >::size(), Isis::Gruen::StatsLog(), and Isis::toString().
|
privateinherited |
Run a gradient filter over the chip.
The type of filter is determined by the Gradient keyword in the Algorithm group.
chip | the chip to be filtered |
iException::Programmer | - "Invalid Gradient type." |
Definition at line 927 of file AutoReg.cpp.
References Isis::Buffer::DoubleBuffer(), Isis::Chip::Extract(), Isis::Chip::GetValue(), Isis::Chip::Lines(), Isis::Chip::Samples(), and Isis::Chip::SetValue().
|
inlineinherited |
|
privateinherited |
Test user limits/contraints after the algorithm has converged.
This method is invoked immediately after the Gruen algorithm has converged to test against user specified limits. This call is only valid in the adaptive context as much of the error checking is handled by AutoReg when using the non-adaptive algorithm.
This method tests for convergence, maximum iterations exceeded, tolerance limits of radiometric shift and gain and whether the eigenvalue of the solution exceeds the limit.
The result container is altered should a constraint not be meet which indicates the registration failed.
point | Container with point information |
Definition at line 1090 of file Gruen.cpp.
References Isis::Statistics::AddData(), Isis::Gruen::getAffineConstraint(), Isis::MatchPoint::getAffinePoint(), Isis::Coordinate::getDistance(), Isis::Gruen::logError(), and Isis::AutoReg::Tolerance().
Referenced by Isis::Gruen::Registration().
|
inlineinherited |
Return the search chip line that best matched.
Definition at line 335 of file AutoReg.h.
References Isis::AutoReg::p_chipLine.
|
inlineinherited |
Return the search chip sample that best matched.
Definition at line 330 of file AutoReg.h.
References Isis::AutoReg::p_chipSample.
|
privateinherited |
Compute Cholesky solution.
a | |
p |
Definition at line 341 of file Gruen.cpp.
References Isis::IException::Programmer.
Referenced by Isis::Gruen::algorithm().
|
privateinherited |
Compute Cholesky solution matrix from correlation.
a | |
p | |
b | |
x |
Definition at line 383 of file Gruen.cpp.
Referenced by Isis::Gruen::algorithm().
|
protectedvirtualinherited |
This virtual method must return if the 1st fit is equal to or better than the second fit.
fit1 | 1st goodness of fit |
fit2 | 2nd goodness of fit |
Reimplemented from Isis::AutoReg.
|
privateinherited |
This method computes the given Chip's Z-Score.
If this value is less than the minimum pattern Z-Score or greater than the negative of the minimum pattern Z-Score, the method will return false. Otherwise, it returns true.
chip | Chip object whose Z-Score is calculated |
Definition at line 895 of file AutoReg.cpp.
References Isis::Statistics::AddData(), Isis::Chip::GetValue(), Isis::Chip::Lines(), Isis::Statistics::Maximum(), Isis::Statistics::Minimum(), Isis::Chip::Samples(), and Isis::Statistics::ZScore().
|
inlineprivateinherited |
Helper method to initialize parameters.
This method will check the existance of a keyword and extract the value
if it exists to the passed parameter (type). If it doesn't exist, the default values is returned.
T | Templated variable type |
conf | Parameter profile container |
keyname | Name of keyword to get a value from |
defval | Default value it keyword/value doesn't exist |
index | Optional index of the value for keyword arrays |
Definition at line 241 of file Gruen.h.
References Isis::DbProfile::count(), Isis::DbProfile::exists(), Isis::IString::ToQt(), and Isis::DbProfile::value().
Referenced by Isis::Gruen::init().
|
inlineprivateinherited |
Helper method to initialize parameters.
This method will check the existance of a keyword and extract the value
if it exists to the passed parameter (type). If it doesn't exist, the default values is returned.
T | Templated variable type |
conf | Parameter profile container |
keyname | Name of keyword to get a value from |
defval | Default value it keyword/value doesn't exist |
index | Optional index of the value for keyword arrays |
Definition at line 272 of file Gruen.h.
References Isis::DbProfile::count(), Isis::DbProfile::exists(), and Isis::DbProfile::value().
|
inlineinherited |
Return the search chip cube line that best matched.
Definition at line 345 of file AutoReg.h.
References Isis::AutoReg::p_cubeLine.
Referenced by Isis::SmtkMatcher::makeRegisteredPoint(), Isis::ControlMeasureEditWidget::registerPoint(), and Isis::ControlPointEdit::registerPoint().
|
inlineinherited |
Return the search chip cube sample that best matched.
Definition at line 340 of file AutoReg.h.
References Isis::AutoReg::p_cubeSample.
Referenced by Isis::SmtkMatcher::makeRegisteredPoint(), Isis::ControlMeasureEditWidget::registerPoint(), and Isis::ControlPointEdit::registerPoint().
|
inlineprivateinherited |
Returns number of degrees of freedom of points.
Definition at line 347 of file Gruen.h.
Referenced by Isis::Gruen::errorAnalysis().
|
inlineinherited |
Return the distance point moved.
sampDistance | Sample movement |
lineDistance | Line movement |
Definition at line 310 of file AutoReg.h.
References Isis::AutoReg::p_lineMovement, and Isis::AutoReg::p_sampMovement.
Referenced by Isis::ControlMeasureEditWidget::registerPoint(), and Isis::ControlPointEdit::registerPoint().
|
inlineinherited |
Return distance tolerance.
Definition at line 300 of file AutoReg.h.
References Isis::AutoReg::p_distanceTolerance.
Referenced by Isis::ControlMeasureEditWidget::registerPoint(), and Isis::ControlPointEdit::registerPoint().
|
privateinherited |
Sort eigenvectors from highest to lowest.
evals | |
evecs |
Definition at line 556 of file Gruen.cpp.
Referenced by Isis::Gruen::errorAnalysis().
|
protectedinherited |
Compute the error analysis of convergent Gruen matrix.
npts | |
resid | |
atai |
Definition at line 289 of file Gruen.cpp.
References Isis::Gruen::DegreesOfFreedom(), Isis::Gruen::EigenSort(), Isis::Gruen::Jacobi(), Isis::Gruen::logError(), and Isis::IException::toString().
Referenced by Isis::Gruen::MatchAlgorithm(), and Isis::Gruen::Registration().
|
inlineinherited |
Return pointer to fit chip.
Definition at line 212 of file AutoReg.h.
References Isis::AutoReg::p_fitChip.
Referenced by Isis::ControlMeasureEditWidget::saveChips(), and Isis::ControlPointEdit::saveChips().
|
inlineinherited |
Returns the Affine tolerance constraint as read from config file.
Definition at line 95 of file Gruen.h.
Referenced by Isis::Gruen::CheckConstraints().
|
inlineinherited |
Return current state of Affine/Radio state
Definition at line 104 of file Gruen.h.
Referenced by Isis::Gruen::init().
|
inherited |
Return set of tolerances for affine convergence.
Definition at line 1066 of file Gruen.cpp.
Referenced by Isis::Gruen::Registration().
|
privateinherited |
Compute the chip coordinate of the registered pixel.
chip | Chip to update with registration parameters |
point | Registration match information |
Definition at line 1141 of file Gruen.cpp.
References Isis::Chip::ChipLine(), Isis::Chip::ChipSample(), Isis::Chip::CubeLine(), Isis::Chip::CubeSample(), Isis::MatchPoint::getAffinePoint(), Isis::Chip::SetChipPosition(), Isis::Chip::TackCube(), Isis::Chip::TackLine(), and Isis::Chip::TackSample().
Referenced by Isis::Gruen::Registration().
|
inlineinherited |
Returns default settings for Affine/Radiometric parameters.
Definition at line 101 of file Gruen.h.
Referenced by Isis::Gruen::setAffineRadio().
|
staticprivateinherited |
Load default Gruen parameter file in $ISISROOT/appdata/templates.
Definition at line 803 of file Gruen.cpp.
Referenced by Isis::Gruen::Gruen().
|
inlineprivateinherited |
Returns the default radiometric gain value.
Definition at line 342 of file Gruen.h.
Referenced by Isis::Gruen::init(), and Isis::Gruen::MatchAlgorithm().
|
inlineinherited |
Returns the register state of the last successful Gruen match.
This method returns the full match condition of the last call to Gruen Register function that was successful.
BEWARE: This is only valid if Register returns successfully! This is due to AutoReg returning conditions that occur prior to the actual Gruen algorithm being called.
Definition at line 120 of file Gruen.h.
Referenced by Isis::SmtkMatcher::makeRegisteredPoint().
|
inlineinherited |
Returns the SPICE tolerance constraint as read from config file.
Definition at line 92 of file Gruen.h.
Referenced by Isis::SmtkMatcher::makeRegisteredPoint().
|
inlineinherited |
Return the goodness of fit of the match algorithm.
Definition at line 323 of file AutoReg.h.
References Isis::AutoReg::p_goodnessOfFit.
Referenced by Isis::ControlMeasureEditWidget::registerPoint(), Isis::ControlPointEdit::registerPoint(), Isis::ControlMeasureEditWidget::saveMeasure(), and Isis::ControlPointEdit::saveMeasure().
|
inlineprotectedvirtualinherited |
Returns the ideal fit for a perfect Gruen result.
Implements Isis::AutoReg.
|
privateinherited |
Initialize AutoReg object private variables.
Fill fit chip, reduced pattern chip and reduced search chip with nulls.
Definition at line 114 of file AutoReg.cpp.
References Isis::Null.
|
privateinherited |
Initialize the object.
This method reads from the Algorithm group (if it exists) to set variables used in this object. If not all the keywords are present, then appropriate values are provided.
PvlObject | &pvl PVL object/groups that contain algorithm parameters |
Definition at line 967 of file Gruen.cpp.
References Isis::Gruen::ConfKey(), Isis::PvlObject::findGroup(), Isis::Gruen::getAffineRadio(), Isis::Gruen::getDefaultRadio(), Isis::PvlObject::hasObject(), Isis::Gruen::initErrorList(), Isis::DbProfile::Name(), Isis::DbProfile::setName(), Isis::toDouble(), Isis::toInt(), Isis::toString(), and Isis::PvlObject::Traverse.
Referenced by Isis::Gruen::Gruen().
|
privateinherited |
Creates an error list from know Gruen errors.
This method creates the list of known/expected Gruen errors that might occur during processing. This should be closely maintained with the ErrorTypes enum list.
Definition at line 922 of file Gruen.cpp.
References Isis::CollectorMap< K, T, ComparePolicy, RemovalPolicy, CopyPolicy >::add().
Referenced by Isis::Gruen::init().
|
inlinevirtual |
|
inlineinherited |
Returns true if the fit parameter is arbitrarily close to the ideal fit value.
fit | Fit value to be compared to the ideal fit |
Definition at line 1162 of file AutoReg.cpp.
|
privateinherited |
Compute the Jacobian of a covariance matrix.
a | |
evals | |
evecs | |
MaxIters |
Definition at line 427 of file Gruen.cpp.
References Isis::IException::Programmer.
Referenced by Isis::Gruen::errorAnalysis().
|
privateinherited |
Logs a Gruen error.
A running count of errors that occur is maintained through this method. If an error occurs that is not in the list, it will also be counted. This would indicate that a new error condition has occured and needs to be added to the list.
gerrno | One of the errors as defined by GruenError enum |
gerrmsg | Optional message although it is ignored in this context |
Definition at line 948 of file Gruen.cpp.
References Isis::CollectorMap< K, T, ComparePolicy, RemovalPolicy, CopyPolicy >::exists(), and Isis::CollectorMap< K, T, ComparePolicy, RemovalPolicy, CopyPolicy >::get().
Referenced by Isis::Gruen::algorithm(), Isis::Gruen::CheckConstraints(), Isis::Gruen::errorAnalysis(), and Isis::Gruen::Registration().
|
privateinherited |
Empty copy constructor.
Here we walk from start sample to end sample and start line to end line, and compare the pattern chip against the search chip to find the best line/sample.
original | AutoReg object |
sChip | Search chip |
pChip | Pattern chip |
fChip | Fit chip |
startSamp | Start sample |
endSamp | End sample |
startLine | Start line |
endLine | End line |
iException::Programmer | - "StartSample = EndSample and StartLine = EndLine." |
Definition at line 1031 of file AutoReg.cpp.
References Isis::Chip::Extract(), Isis::Chip::IsValid(), Isis::Chip::Lines(), Isis::Null, Isis::Chip::Samples(), Isis::Chip::SetSize(), and Isis::Chip::SetValue().
Minimization of data set using Gruen algorithm.
This is a very minimal application of the Gruen algorithm that provides the ability to use it in a non-adaptive capacity. This method processes two chips of the same size, pattern and subsearch. The subsearch has typically been extracted in the same manner as the MinimumDifference or MaximumCorrelation routines are utilized.
It simply applies the algorithm to the current state of the two chips, computes the error analysis on it and returns the eigen vector solution as an indication of chip registration integrity.
Note that in this mode, most all the parameters found in the definition file that apply to the adaptive mode are ignored when utilizing the algorithm in this fashion.
pattern | [in] A Chip object usually containing an nxm area of a cube. Must be the same diminsions as subsearch. |
subsearch | [in] A Chip object usually containing an nxm area of a cube. Must be the same dimensions as pattern. This is normally a subarea of a larger portion of the image. |
Implements Isis::AutoReg.
Definition at line 608 of file Gruen.cpp.
References Isis::Gruen::algorithm(), Isis::Gruen::errorAnalysis(), Isis::Gruen::getDefaultRadio(), Isis::Analysis::getEigen(), and Isis::Null.
|
inlineinherited |
Return minimumPatternZScore.
Definition at line 350 of file AutoReg.h.
References Isis::AutoReg::p_minimumPatternZScore.
Referenced by Isis::ControlMeasureEditWidget::registerPoint(), and Isis::ControlPointEdit::registerPoint().
Computes the number of minimum valid points.
This method uses the pattern valid percent as specified in the registration config file (or the programmer) to compute the minimum number of valid points from the total.
totalPoints | Assumed to be total number of relavent pixels in a chip |
Definition at line 1038 of file Gruen.cpp.
References Isis::AutoReg::PatternValidPercent().
Referenced by Isis::Gruen::algorithm(), and Isis::Gruen::ValidPoints().
|
inlinevirtualinherited |
Minimum tolerance specific to algorithm.
Reimplemented in Isis::MinimumDifference.
|
inlineprivateinherited |
Keyword formatter for Gruen parameters.
Constructs a keyword with actual user/programmer values if provided, otherwise sets the value to "Unbounded".
T | Type of value to record |
keyname | Name of keyword to create |
value | Value to set keyword to if in profile |
unit | Optional unit value |
Definition at line 301 of file Gruen.h.
References Isis::DbProfile::exists(), and Isis::Gruen::ValidateKey().
Referenced by Isis::Gruen::ParameterLog().
|
privateinherited |
Create a PvlGroup with the Gruen specific parameters.
This method generates a PvlGroup of Gruen algorithm parameters. This routine is called from the AutoReg algorithm specific statistics routine and augments the AutoReg log output.
Definition at line 890 of file Gruen.cpp.
References Isis::Gruen::ParameterKey(), Isis::toString(), and Isis::Gruen::ValidateKey().
Referenced by Isis::Gruen::AlgorithmStatistics().
|
protectedinherited |
Initialize parameters in the AutoReg class using a PVL specification.
An example of the PVL required for this is:
There are many other options that can be set via the pvl and are described in other documentation (see below).
pvl | The pvl object containing the specification |
iException::User | "Improper format for AutoReg PVL." |
Definition at line 194 of file AutoReg.cpp.
References Isis::PvlContainer::fileName(), Isis::PvlObject::findGroup(), Isis::PvlObject::findObject(), Isis::PvlObject::hasGroup(), Isis::PvlContainer::hasKeyword(), Isis::ValidMaximum, and Isis::ValidMinimum.
|
inlineinherited |
Return pointer to pattern chip.
Definition at line 202 of file AutoReg.h.
References Isis::AutoReg::p_patternChip.
Referenced by Isis::ControlMeasureEditWidget::registerPoint(), and Isis::ControlPointEdit::registerPoint().
|
inlineinherited |
Return pattern chip valid percent. The default value is.
Definition at line 280 of file AutoReg.h.
References Isis::AutoReg::p_patternValidPercent.
Referenced by Isis::MaximumCorrelation::MatchAlgorithm(), Isis::Gruen::MinValidPoints(), Isis::ControlMeasureEditWidget::registerPoint(), and Isis::ControlPointEdit::registerPoint().
This method reduces the given chip by the given reduction factor.
Used to speed up the match algorithm.
chip | Chip to be reduced |
reductionFactor | Factor by which to reduce chip. |
Definition at line 539 of file AutoReg.cpp.
References Isis::Statistics::AddData(), Isis::Statistics::Average(), Isis::Chip::GetValue(), Isis::Chip::Lines(), Isis::Null, Isis::Statistics::Reset(), Isis::Chip::Samples(), and Isis::Chip::SetValue().
|
inlineinherited |
Return pointer to reduced fit chip.
Definition at line 247 of file AutoReg.h.
References Isis::AutoReg::p_reducedFitChip.
|
inlineinherited |
Return pointer to reduced pattern chip.
Definition at line 237 of file AutoReg.h.
References Isis::AutoReg::p_reducedPatternChip.
|
inlineinherited |
Return pointer to reduced search chip.
Definition at line 242 of file AutoReg.h.
References Isis::AutoReg::p_reducedSearchChip.
|
inlineinherited |
Return the reduction factor.
Definition at line 275 of file AutoReg.h.
References Isis::AutoReg::p_reduceFactor.
|
inherited |
Walk the pattern chip through the search chip to find the best registration.
iException::User | - "Search chips samples must be at least N pixels wider than the pattern chip samples for successful surface modeling" |
iException::User | - "Search chips lines must be at least N pixels taller than the pattern chip lines for successful surface modeling" |
iException::User | - "Reduction factor is too large" |
Prep for walking the search chip by computing the starting and ending sample and line positions of the search chip to extract a sub-search chip to compare with the pattern chip.
Because the sub-search chip needs to have the same pixel dimensions as the pattern chip, and will be composed from its center pixel outwards, buffer the start and end boundaries so an area the size of the pattern chip can always be extracted around the current position.
For example, consider trying to extract a 5x5 sub-search chip from some search chip. If one starts at sample 1 and line 1, then because the "current position" is treated as the center of the sub-search chip, the algorithm could not form a 5x5 chip because there is nothing up and to the left of the current position. Consequently, for this example, there needs to be a two-pixel buffer from the edge of the search chip as the algorithm walks through it to make sure a 5x5 sub-search chip can always be extracted with the current position as its center.
Definition at line 587 of file AutoReg.cpp.
References Isis::Chip::CubeLine(), Isis::Chip::CubeSample(), Isis::Chip::IsValid(), Isis::Chip::Lines(), Isis::Null, Isis::Chip::Samples(), Isis::Chip::SetChipPosition(), Isis::Chip::TackLine(), and Isis::Chip::TackSample().
Referenced by Isis::SmtkMatcher::makeRegisteredPoint(), Isis::ControlMeasureEditWidget::registerPoint(), and Isis::ControlPointEdit::registerPoint().
|
protectedvirtualinherited |
Applies the adaptive Gruen algorithm to pattern and search chips.
This method computes the adaptive Gruen algorithm for a pattern chip and search chip. The search chip is assumed to be of a larger size than the pattern chip as dictated by the contents of the registration definition file.
This algorithm can be used with or without "fast geoming" the search chip. It works quite well where the two images are assumed to be nearly spatially registered. Its real intent is to compute parallax angles between two images taken at different viewing geometry. This provides an efficient process for deriving a digital elevation model (DEM) from two datasets.
The Gruen algorithm is applied to the chips until the algorithm converges (current iteration yields a detla affine within tolerance limits), an error is encountered, or the maximum number of iterations is exceeded.
Note that bestSamp and bestLine may not be the original center of the search chip. It is subject to chip reduction matching as specified by the user. All distance tolerances are compute from this postion. The process of chip reduction processing is handled by AutoReg prior to calling this routine.
sChip | Full search chip as rendered from the search image |
pChip | Full pattern chip as rendered from the pattern/match image |
fChip | Maintains the solution vector at each chip location |
startSamp | Starting sample of the search image range |
startLine | Starting line of the search image range |
endSamp | Ending sample of the search image range |
endLine | Ending line of the search image range |
bestSamp | Best registering sample of search chip |
bestLine | best registering line of search chip |
Reimplemented from Isis::AutoReg.
Definition at line 680 of file Gruen.cpp.
References Isis::Gruen::algorithm(), Isis::Gruen::CheckConstraints(), Isis::Gruen::errorAnalysis(), Isis::Chip::Extract(), Isis::Gruen::getAffineTolerance(), Isis::Gruen::getChipUpdate(), Isis::Threshold::hasConverged(), Isis::Chip::Lines(), Isis::Gruen::logError(), Isis::Chip::Samples(), Isis::AutoReg::SetChipLine(), Isis::Chip::SetChipPosition(), Isis::AutoReg::SetChipSample(), Isis::AutoReg::SetGoodnessOfFit(), Isis::Chip::SetSize(), Isis::Gruen::Status(), Isis::Chip::TackLine(), Isis::Chip::TackSample(), Isis::AffineRadio::Translate(), and Isis::Chip::Write().
|
inlineinherited |
Return pointer to pattern chip used in registration.
Definition at line 217 of file AutoReg.h.
References Isis::AutoReg::None, Isis::AutoReg::p_gradientFilterType, Isis::AutoReg::p_gradientPatternChip, and Isis::AutoReg::p_patternChip.
Referenced by Isis::ControlMeasureEditWidget::saveChips(), and Isis::ControlPointEdit::saveChips().
|
inlineinherited |
Return pointer to search chip used in registration.
Definition at line 227 of file AutoReg.h.
References Isis::AutoReg::None, Isis::AutoReg::p_gradientFilterType, Isis::AutoReg::p_gradientSearchChip, and Isis::AutoReg::p_searchChip.
Referenced by Isis::ControlMeasureEditWidget::saveChips(), and Isis::ControlPointEdit::saveChips().
|
inherited |
This returns the cumulative registration statistics.
That is, the Register() method accumulates statistics regard the errors each time is called. Invoking this method returns a PVL summary of those statisitics
Definition at line 1177 of file AutoReg.cpp.
References Isis::PvlObject::addGroup(), and Isis::toString().
|
inherited |
This function returns the keywords that this object was created from.
Definition at line 1216 of file AutoReg.cpp.
References Isis::PvlContainer::hasKeyword().
|
privateinherited |
Reset Gruen statistics as needed.
Definition at line 1018 of file Gruen.cpp.
References Isis::Statistics::Reset().
|
inlineinherited |
Return pointer to search chip.
Definition at line 207 of file AutoReg.h.
References Isis::AutoReg::p_searchChip.
Referenced by Isis::ControlMeasureEditWidget::registerPoint(), and Isis::ControlPointEdit::registerPoint().
|
inherited |
Set affine parameters to defaults.
This method differs from the one above in that it uses the defaults as defined at construction. The basic difference is that this call sets the affine portion to the identity and the radiometric parameters to the defaults as provided in the user input auto-regististration parameters. It may have default shift and gain values to use.
Definition at line 127 of file Gruen.cpp.
References Isis::Gruen::getDefaultAffineRadio().
|
inherited |
Sets initial chip transformation.
This method can be used with AutoReg registration to set initial affine transform parameters. This initial condition will be applied to the whole search chip extraction for the first subsearch chip. The caller must define the contents of the affine and radiometric parameters. See the AffineRadio construct for details.
affrad | Initial Affine/Radio parameters to apply on registration entry |
|
inherited |
Sets the Chip class interpolator type to be used to load pattern and search chips.
Acceptable values for the interpolator parameter include:
If this method is not called, the chip interpolator type defaults to CubicConvolutionType in the Chip class.
interpolator | Name of interpolator type to be used. This is taken from the Pvl's ChipInterpolator keyword value. |
iException::User | - "Invalid Interpolator type." |
Definition at line 440 of file AutoReg.cpp.
|
inlineprotectedinherited |
Sets the search chip subpixel line that matches the pattern tack line.
line | Value to set for search chip subpixel line |
Definition at line 404 of file AutoReg.h.
References Isis::AutoReg::p_chipLine.
Referenced by Isis::Gruen::Registration().
|
inlineprotectedinherited |
Sets the search chip subpixel sample that matches the pattern tack sample.
sample | Value to set for search chip subpixel sample |
Definition at line 393 of file AutoReg.h.
References Isis::AutoReg::p_chipSample.
Referenced by Isis::Gruen::Registration().
|
inlineprotectedinherited |
Sets the goodness of fit for adaptive algorithms.
fit | Fit value to set |
Definition at line 413 of file AutoReg.h.
References Isis::AutoReg::p_bestFit.
Referenced by Isis::Gruen::Registration().
|
inherited |
Set the gradient filter type to be applied to the search and pattern chips.
gradientFilterType | the gradient filter type to use |
iException::User | - "Invalid Gradient type." |
Definition at line 273 of file AutoReg.cpp.
|
inherited |
Set the amount of data in the pattern chip that must be valid.
For example, a 21x21 pattern chip has 441 pixels. If percent is 75 then at least 330 pixels pairs must be valid in order for a comparision between the pattern and search sub-region to occur. That is, both the pattern pixel and search pixel must be valid to be counted. Pixels are considered valid based on the min/max range specified on each of the Chips (see Chip::SetValidRange method).
If the pattern chip reduction option is used this percentage will apply to all reduced patterns. Additionally, the pattern sampling effects the pixel count. For example if pattern sampling is 50% then only 220 pixels in the 21x21 pattern are considered so 165 must be valid.
If this method is not called, the PatternChip ValidPercent defaults to 50 in the AutoReg object constructor.
percent | Percentage of valid data between 0 and 100, default is 50% if never invoked |
iException::User | - "Invalid value for PatternChip ValidPercent." |
Definition at line 339 of file AutoReg.cpp.
|
inherited |
Set the minimum pattern zscore.
This option is used to ignore pattern chips which are bland (low standard deviation). If the minimum or maximum pixel value in the pattern chip does not meet the minimum zscore value (see a statisitcs book for definition of zscore) then invalid registration will occur.
If this method is not called, the z-score minimum defaults to 1.0 in the AutoReg object constructor.
minimum | The minimum zscore value for the pattern chip. Default is 1.0 |
iException::User | - "Invalid value for PatternChip MinimumZScore." |
Definition at line 394 of file AutoReg.cpp.
|
inherited |
Set the reduction factor used to speed up the pattern matching algorithm.
If this method is not called, the reduction factor defaults to 1 in the AutoReg object constructor.
factor | Reduction factor. Must be greater than or equal to 1. |
iException::User | - "Invalid value for Algorithm ReductionFactor." |
Definition at line 521 of file AutoReg.cpp.
|
inherited |
If the sub-pixel accuracy is enabled, the Register() method will attempt to match the pattern chip to the search chip at sub-pixel accuracy, otherwise it will be registered at whole pixel accuracy.
If this method is not called, the sub pixel accuracy defaults to on = true in the AutoReg object constructor.
on | Set the state of registration accuracy. The default is sub-pixel accuracy is on |
Definition at line 312 of file AutoReg.cpp.
|
protectedinherited |
Set the search chip sample and line to subpixel values if possible.
This method uses a centroiding method to gravitate the whole pixel best fit to a subpixel extremum in the continuous image space. The weights of the centers of gravity in the centroiding algorithm are modeled by goodness of fit values within a discrete search window.
window | The search window extracted from the fit chip |
Definition at line 1087 of file AutoReg.cpp.
References Isis::Chip::ChipLine(), Isis::Chip::ChipSample(), Isis::Chip::GetValue(), Isis::Chip::Lines(), Isis::Chip::Samples(), Isis::Centroid::select(), Isis::Centroid::setDNRange(), and Isis::Chip::SetValue().
|
inherited |
Set the amount of data in the search chip's subchip that must be valid.
If this method is not called, the SearchChip SubchipValidPercent defaults to 50 in the AutoReg object constructor.
percent | Percentage of valid data between 0 and 100, default is 50% if never invoked |
iException::User | - "Invalid value for SearchChip SubchipValidPercent." |
Definition at line 367 of file AutoReg.cpp.
|
inherited |
Set a distance the surface model solution is allowed to move away from the best whole pixel fit in the fit chip.
If this method is not called, the distance tolerance defaults to 1.5 in the AutoReg object constructor.
distance | The distance allowed to move in pixels. Must be greater than 0. |
iException::User | - "Invalid value for SurfaceModel DistanceTolerance." |
Definition at line 501 of file AutoReg.cpp.
|
inherited |
Set the surface model window size.
The pixels in this window will be used to fit a surface model in order to compute sub-pixel accuracy. In some cases the default (3x3) and produces erroneous sub-pixel accuracy values.
If this method is not called, the window size defaults to 5 in the AutoReg object constructor.
size | The size of the window must be three or greater and odd. |
iException::User | - "Invalid value for SurfaceModel WindowSize." |
Definition at line 480 of file AutoReg.cpp.
|
inherited |
Set the tolerance for an acceptable goodness of fit.
If this method is not called, the tolerance value defaults to Isis::Null in the AutoReg object constructor.
tolerance | This tolerance is used to test against the goodness of fit returned by the MatchAlgorith method after a surface model has been fit. See TestGoodnessOfFit |
Definition at line 416 of file AutoReg.cpp.
|
privateinherited |
Compute a Sobel gradient based on an input buffer.
TODO: Remove this method as it already exists in the gradient application.
in | the input buffer |
v | the value of the gradient computed from the buffer |
Definition at line 1000 of file AutoReg.cpp.
References Isis::IsSpecial(), Isis::Null, and Isis::Buffer::size().
|
privateinherited |
Create a PvlGroup with the Gruen specific statistics.
This method generates a PvlGroup from statistics collected for a particular Gruen algorithm application. This routine is called from the AutoReg algorithm specific statistics routine and augments the AutoReg statistics log output.
Definition at line 853 of file Gruen.cpp.
References Isis::Statistics::Average(), Isis::Statistics::Maximum(), Isis::Statistics::Minimum(), Isis::Statistics::StandardDeviation(), Isis::toString(), and Isis::Gruen::ValidateKey().
Referenced by Isis::Gruen::AlgorithmStatistics().
|
privateinherited |
Returns the proper status given a Gruen result container.
This method will return registration status consistant with AutoReg::RegisterStatus return codes.
result | Gruen result container used to determine status |
Definition at line 1161 of file Gruen.cpp.
References Isis::AutoReg::AdaptiveAlgorithmFailed, and Isis::AutoReg::SuccessSubPixel.
Referenced by Isis::Gruen::Registration().
|
inlineinherited |
Return whether this object will attempt to register to whole or sub-pixel accuracy.
Definition at line 270 of file AutoReg.h.
References Isis::AutoReg::p_subpixelAccuracy.
|
inlineinherited |
Return subsearch chip valid percent.
Definition at line 285 of file AutoReg.h.
References Isis::AutoReg::p_subsearchValidPercent.
|
inlineinherited |
Return whether the match algorithm succeeded or not.
Definition at line 318 of file AutoReg.h.
References Isis::AutoReg::p_registrationStatus, Isis::AutoReg::SuccessPixel, and Isis::AutoReg::SuccessSubPixel.
Referenced by Isis::ControlMeasureEditWidget::registerPoint(), and Isis::ControlPointEdit::registerPoint().
|
inlineinherited |
Return match algorithm tolerance.
Definition at line 290 of file AutoReg.h.
References Isis::AutoReg::p_tolerance.
Referenced by Isis::Gruen::CheckConstraints(), Isis::ControlMeasureEditWidget::registerPoint(), and Isis::ControlPointEdit::registerPoint().
|
inherited |
Returns a PvlGroup containing the PvlKeywords of the parameters this object was most recently run with.
Because of publically accessible mutators, AutoReg's runtime parameters can change, and this version of the template is designed to reflect the paramters it was actually run with, as opposed to simply initialized with. If no mutators were ever called externally, then this PvlGroup should be the same as the one received from RegTemplate().
Definition at line 1289 of file AutoReg.cpp.
References Isis::Chip::Lines(), Isis::Chip::Samples(), and Isis::toString().
|
inlineprivateinherited |
Checks value of key, produces appropriate value.
This function checks the value of the keyword for specialness and will create the appropriate keyword if it is special.
keyname | Name of keyword to create |
value | Keyword value |
unit | Optional unit qualifer with value |
Definition at line 323 of file Gruen.h.
References Isis::IsSpecial(), and Isis::toString().
Referenced by Isis::Gruen::ParameterKey(), Isis::Gruen::ParameterLog(), and Isis::Gruen::StatsLog().
Determines if number of points is valid percentage of all points.
Computes the number of minimum valid points from user specified percentage and tests the acutal number used.
totalPoints | Total number of possible valid points in chip |
nPoints | Actual number of valid points used in chips |
Definition at line 1055 of file Gruen.cpp.
References Isis::Gruen::MinValidPoints().
Referenced by Isis::Gruen::algorithm().
|
inlineinherited |
Return window size.
Definition at line 295 of file AutoReg.h.
References Isis::AutoReg::p_windowSize.
|
inherited |
Set up for writing subsearch for a a given registration call.
This method is provided to request the write of the subsearch chip at each iteration. This must be invoked prior to every call to AutoReg::Register() method. It will only write subchips from the Register() interface as it interates to a solution. Direct calls to Gruen methods don't iterate in the same fashion.
The "pattern" parameter is optional but is provided to direct the location and naming convention of each subsearch chip. The format for the output file name for each subsearch chip is comprised of the pattern parameter, call number, which can be retrieved by the CallCount() method and pertains to the call after the Register() method is invoked and the interation count. Below is a code example:
Note that prior to each call to Register(), it must be called again in order for the subchips to be written. The last part of the parameter above, "subchip", cannot be a directory, but is a filename prefix. Assuming this is the first call to Register(), a series of cube subsearch chips will be written with the pattern "/work1/kbecker/subchipC000001IXXX.cub" where "C" indicates call count and the next 6 digits are the return of CallCount() method, "I" indicates the iteration count "XXX" of the algorithm() method. Note that the chip written for a particular iteration is what is provided as a parameter into the algorithm() method.
pattern | Specifies an optional directory and file pattern to write the subsearch chip at each algorithm iteration. |
|
inlineinherited |
Return the ZScores of the pattern chip.
score1 | First Z Score |
score2 | Second Z Score |
Definition at line 360 of file AutoReg.h.
References Isis::AutoReg::p_zScoreMax, and Isis::AutoReg::p_zScoreMin.
Referenced by Isis::ControlMeasureEditWidget::registerPoint(), Isis::ControlPointEdit::registerPoint(), Isis::ControlMeasureEditWidget::saveMeasure(), and Isis::ControlPointEdit::saveMeasure().
|
privateinherited |
Goodness of fit for adaptive algorithms.
Definition at line 523 of file AutoReg.h.
Referenced by Isis::AutoReg::SetGoodnessOfFit().
|
privateinherited |
|
privateinherited |
|
privateinherited |
Chip line.
Definition at line 514 of file AutoReg.h.
Referenced by Isis::AutoReg::ChipLine(), and Isis::AutoReg::SetChipLine().
|
privateinherited |
Chip sample.
Definition at line 513 of file AutoReg.h.
Referenced by Isis::AutoReg::ChipSample(), and Isis::AutoReg::SetChipSample().
|
privateinherited |
|
privateinherited |
|
privateinherited |
Maximum distance the surface model solution may be from the best whole pixel fit in the fit chip.
Definition at line 521 of file AutoReg.h.
Referenced by Isis::AutoReg::DistanceTolerance().
|
privateinherited |
Results from MatchAlgorithm() method.
Definition at line 485 of file AutoReg.h.
Referenced by Isis::AutoReg::FitChip().
|
privateinherited |
|
privateinherited |
|
privateinherited |
Goodness of fit of the match algorithm.
Definition at line 517 of file AutoReg.h.
Referenced by Isis::AutoReg::GoodnessOfFit().
|
privateinherited |
Type of gradient filter to use before matching.
Definition at line 530 of file AutoReg.h.
Referenced by Isis::AutoReg::RegistrationPatternChip(), and Isis::AutoReg::RegistrationSearchChip().
|
privateinherited |
Chip to be matched with gradient applied.
Definition at line 487 of file AutoReg.h.
Referenced by Isis::AutoReg::RegistrationPatternChip().
|
privateinherited |
Chip to be searched for best registration with gradient applied.
Definition at line 486 of file AutoReg.h.
Referenced by Isis::AutoReg::RegistrationSearchChip().
|
privateinherited |
The number of lines the point moved.
Definition at line 527 of file AutoReg.h.
Referenced by Isis::AutoReg::Distance().
|
privateinherited |
Minimum pattern Z-Score.
Definition at line 509 of file AutoReg.h.
Referenced by Isis::AutoReg::MinimumZScore().
|
privateinherited |
Chip to be matched.
Definition at line 483 of file AutoReg.h.
Referenced by Isis::AutoReg::PatternChip(), and Isis::AutoReg::RegistrationPatternChip().
|
privateinherited |
|
privateinherited |
Percentage of data in pattern chip that must be valid.
Definition at line 510 of file AutoReg.h.
Referenced by Isis::AutoReg::PatternValidPercent().
|
privateinherited |
|
privateinherited |
|
privateinherited |
Fit Chip with reduction factor.
Definition at line 490 of file AutoReg.h.
Referenced by Isis::AutoReg::ReducedFitChip().
|
privateinherited |
Pattern Chip with reduction factor.
Definition at line 488 of file AutoReg.h.
Referenced by Isis::AutoReg::ReducedPatternChip().
|
privateinherited |
Search Chip with reduction factor.
Definition at line 489 of file AutoReg.h.
Referenced by Isis::AutoReg::ReducedSearchChip().
|
privateinherited |
Reduction factor.
Definition at line 528 of file AutoReg.h.
Referenced by Isis::AutoReg::ReductionFactor().
|
privateinherited |
Registration status to be returned by Register().
Definition at line 529 of file AutoReg.h.
Referenced by Isis::AutoReg::Success().
|
privateinherited |
The number of samples the point moved.
Definition at line 526 of file AutoReg.h.
Referenced by Isis::AutoReg::Distance().
|
privateinherited |
Chip to be searched for best registration.
Definition at line 484 of file AutoReg.h.
Referenced by Isis::AutoReg::RegistrationSearchChip(), and Isis::AutoReg::SearchChip().
|
privateinherited |
Indicates whether sub-pixel accuracy is enabled. Default is true.
Definition at line 492 of file AutoReg.h.
Referenced by Isis::AutoReg::SubPixelAccuracy().
|
privateinherited |
|
privateinherited |
Percentage of data in subsearch chip that must be valid.
Definition at line 511 of file AutoReg.h.
Referenced by Isis::AutoReg::SubsearchValidPercent().
|
privateinherited |
|
privateinherited |
|
privateinherited |
|
protectedinherited |
|
privateinherited |
Tolerance for acceptable goodness of fit in match algorithm.
Definition at line 518 of file AutoReg.h.
Referenced by Isis::AutoReg::Tolerance().
|
privateinherited |
Registration Statistics Total keyword.
|
privateinherited |
Surface model window size.
Definition at line 520 of file AutoReg.h.
Referenced by Isis::AutoReg::WindowSize().
|
privateinherited |
Second Z-Score of pattern chip.
Definition at line 507 of file AutoReg.h.
Referenced by Isis::AutoReg::ZScores().
|
privateinherited |
First Z-Score of pattern chip.
Definition at line 506 of file AutoReg.h.
Referenced by Isis::AutoReg::ZScores().