cleaning, removing goto's, uniformization (try to reduce diff between

hybr[dj].h  or lm[der,dif,str].h as much as possible), for future merging.
This commit is contained in:
Thomas Capricelli 2009-08-24 16:05:57 +02:00
parent 91a2145cb3
commit 63071ac968
5 changed files with 493 additions and 640 deletions

View File

@ -46,8 +46,7 @@ int ei_lmder(
/* check the input parameters for errors. */ /* check the input parameters for errors. */
if (n <= 0 || m < n || ftol < 0. || xtol < 0. || if (n <= 0 || m < n || ftol < 0. || xtol < 0. || gtol < 0. || maxfev <= 0 || factor <= 0.)
gtol < 0. || maxfev <= 0 || factor <= 0.)
goto L300; goto L300;
if (mode == 2) if (mode == 2)
@ -70,7 +69,7 @@ int ei_lmder(
/* beginning of the outer loop. */ /* beginning of the outer loop. */
while(true) { while (true) {
/* calculate the jacobian matrix. */ /* calculate the jacobian matrix. */
@ -104,8 +103,10 @@ int ei_lmder(
if (wa2[j] == 0.) if (wa2[j] == 0.)
diag[j] = 1.; diag[j] = 1.;
} }
/* on the first iteration, calculate the norm of the scaled x */ /* on the first iteration, calculate the norm of the scaled x */
/* and initialize the step bound delta. */ /* and initialize the step bound delta. */
wa3 = diag.cwise() * x; wa3 = diag.cwise() * x;
xnorm = wa3.stableNorm(); xnorm = wa3.stableNorm();
delta = factor * xnorm; delta = factor * xnorm;
@ -147,9 +148,8 @@ int ei_lmder(
/* test for convergence of the gradient norm. */ /* test for convergence of the gradient norm. */
if (gnorm <= gtol) { if (gnorm <= gtol)
info = 4; info = 4;
}
if (info != 0) if (info != 0)
break; break;
@ -160,6 +160,7 @@ int ei_lmder(
/* beginning of the inner loop. */ /* beginning of the inner loop. */
do { do {
/* determine the levenberg-marquardt parameter. */ /* determine the levenberg-marquardt parameter. */
ei_lmpar<Scalar>(fjac, ipvt, diag, qtf, delta, par, wa1, wa2); ei_lmpar<Scalar>(fjac, ipvt, diag, qtf, delta, par, wa1, wa2);
@ -173,9 +174,8 @@ int ei_lmder(
/* on the first iteration, adjust the initial step bound. */ /* on the first iteration, adjust the initial step bound. */
if (iter == 1) { if (iter == 1)
delta = std::min(delta,pnorm); delta = std::min(delta,pnorm);
}
/* evaluate the function at x + p and calculate its norm. */ /* evaluate the function at x + p and calculate its norm. */
@ -198,10 +198,9 @@ int ei_lmder(
for (j = 0; j < n; ++j) { for (j = 0; j < n; ++j) {
l = ipvt[j]; l = ipvt[j];
temp = wa1[l]; temp = wa1[l];
for (i = 0; i <= j; ++i) { for (i = 0; i <= j; ++i)
wa3[i] += fjac(i,j) * temp; wa3[i] += fjac(i,j) * temp;
} }
}
temp1 = ei_abs2(wa3.stableNorm() / fnorm); temp1 = ei_abs2(wa3.stableNorm() / fnorm);
temp2 = ei_abs2(ei_sqrt(par) * pnorm / fnorm); temp2 = ei_abs2(ei_sqrt(par) * pnorm / fnorm);
/* Computing 2nd power */ /* Computing 2nd power */
@ -227,13 +226,10 @@ int ei_lmder(
/* Computing MIN */ /* Computing MIN */
delta = temp * std::min(delta, pnorm / Scalar(.1)); delta = temp * std::min(delta, pnorm / Scalar(.1));
par /= temp; par /= temp;
} } else if (!(par != 0. && ratio < Scalar(.75))) {
else {
if (!(par != 0. && ratio < Scalar(.75))) {
delta = pnorm / Scalar(.5); delta = pnorm / Scalar(.5);
par = Scalar(.5) * par; par = Scalar(.5) * par;
} }
}
/* test for successful iteration. */ /* test for successful iteration. */
@ -277,7 +273,6 @@ int ei_lmder(
L300: L300:
/* termination, either normal or user imposed. */ /* termination, either normal or user imposed. */
if (iflag < 0) if (iflag < 0)
info = iflag; info = iflag;
if (nprint > 0) if (nprint > 0)

View File

@ -45,10 +45,8 @@ int ei_lmdif(
/* check the input parameters for errors. */ /* check the input parameters for errors. */
if (n <= 0 || m < n || ftol < 0. || xtol < 0. || if (n <= 0 || m < n || ftol < 0. || xtol < 0. || gtol < 0. || maxfev <= 0 || factor <= 0.)
gtol < 0. || maxfev <= 0 || factor <= 0.) {
goto L300; goto L300;
}
if (mode == 2) if (mode == 2)
for (j = 0; j < n; ++j) for (j = 0; j < n; ++j)
if (diag[j] <= 0.) goto L300; if (diag[j] <= 0.) goto L300;
@ -58,9 +56,8 @@ int ei_lmdif(
iflag = Functor::f(x, fvec); iflag = Functor::f(x, fvec);
nfev = 1; nfev = 1;
if (iflag < 0) { if (iflag < 0)
goto L300; goto L300;
}
fnorm = fvec.stableNorm(); fnorm = fvec.stableNorm();
/* initialize levenberg-marquardt parameter and iteration counter. */ /* initialize levenberg-marquardt parameter and iteration counter. */
@ -70,29 +67,24 @@ int ei_lmdif(
/* beginning of the outer loop. */ /* beginning of the outer loop. */
L30: while (true) {
/* calculate the jacobian matrix. */ /* calculate the jacobian matrix. */
iflag = ei_fdjac2<Functor,Scalar>(x, fvec, fjac, epsfcn, wa4); iflag = ei_fdjac2<Functor,Scalar>(x, fvec, fjac, epsfcn, wa4);
nfev += n; nfev += n;
if (iflag < 0) { if (iflag < 0)
goto L300; break;
}
/* if requested, call Functor::f to enable printing of iterates. */ /* if requested, call Functor::f to enable printing of iterates. */
if (nprint <= 0) { if (nprint > 0) {
goto L40;
}
iflag = 0; iflag = 0;
if ((iter - 1) % nprint == 0) { if ((iter - 1) % nprint == 0)
iflag = Functor::debug(x, fvec); iflag = Functor::debug(x, fvec);
if (iflag < 0)
break;
} }
if (iflag < 0) {
goto L300;
}
L40:
/* compute the qr factorization of the jacobian. */ /* compute the qr factorization of the jacobian. */
@ -102,20 +94,13 @@ L40:
/* on the first iteration and if mode is 1, scale according */ /* on the first iteration and if mode is 1, scale according */
/* to the norms of the columns of the initial jacobian. */ /* to the norms of the columns of the initial jacobian. */
if (iter != 1) { if (iter == 1) {
goto L80; if (mode != 2)
}
if (mode == 2) {
goto L60;
}
for (j = 0; j < n; ++j) { for (j = 0; j < n; ++j) {
diag[j] = wa2[j]; diag[j] = wa2[j];
if (wa2[j] == 0.) { if (wa2[j] == 0.)
diag[j] = 1.; diag[j] = 1.;
} }
/* L50: */
}
L60:
/* on the first iteration, calculate the norm of the scaled x */ /* on the first iteration, calculate the norm of the scaled x */
/* and initialize the step bound delta. */ /* and initialize the step bound delta. */
@ -123,41 +108,31 @@ L60:
wa3 = diag.cwise() * x; wa3 = diag.cwise() * x;
xnorm = wa3.stableNorm(); xnorm = wa3.stableNorm();
delta = factor * xnorm; delta = factor * xnorm;
if (delta == 0.) { if (delta == 0.)
delta = factor; delta = factor;
} }
L80:
/* form (q transpose)*fvec and store the first n components in */ /* form (q transpose)*fvec and store the first n components in */
/* qtf. */ /* qtf. */
wa4 = fvec; wa4 = fvec;
for (j = 0; j < n; ++j) { for (j = 0; j < n; ++j) {
if (fjac(j,j) == 0.) { if (fjac(j,j) != 0.) {
goto L120;
}
sum = 0.; sum = 0.;
for (i = j; i < m; ++i) { for (i = j; i < m; ++i)
sum += fjac(i,j) * wa4[i]; sum += fjac(i,j) * wa4[i];
/* L100: */
}
temp = -sum / fjac(j,j); temp = -sum / fjac(j,j);
for (i = j; i < m; ++i) { for (i = j; i < m; ++i)
wa4[i] += fjac(i,j) * temp; wa4[i] += fjac(i,j) * temp;
/* L110: */
} }
L120:
fjac(j,j) = wa1[j]; fjac(j,j) = wa1[j];
qtf[j] = wa4[j]; qtf[j] = wa4[j];
/* L130: */
} }
/* compute the norm of the scaled gradient. */ /* compute the norm of the scaled gradient. */
gnorm = 0.; gnorm = 0.;
if (fnorm == 0.) { if (fnorm != 0.)
goto L170;
}
for (j = 0; j < n; ++j) { for (j = 0; j < n; ++j) {
l = ipvt[j]; l = ipvt[j];
if (wa2[l] != 0.) { if (wa2[l] != 0.) {
@ -168,29 +143,21 @@ L120:
gnorm = std::max(gnorm, ei_abs(sum / wa2[l])); gnorm = std::max(gnorm, ei_abs(sum / wa2[l]));
} }
} }
L170:
/* test for convergence of the gradient norm. */ /* test for convergence of the gradient norm. */
if (gnorm <= gtol) { if (gnorm <= gtol)
info = 4; info = 4;
} if (info != 0)
if (info != 0) { break;
goto L300;
}
/* rescale if necessary. */ /* rescale if necessary. */
if (mode == 2) { if (mode != 2) /* Computing MAX */
goto L190;
}
/* Computing MAX */
diag = diag.cwise().max(wa2); diag = diag.cwise().max(wa2);
L190:
/* beginning of the inner loop. */ /* beginning of the inner loop. */
do {
L200:
/* determine the levenberg-marquardt parameter. */ /* determine the levenberg-marquardt parameter. */
@ -205,17 +172,15 @@ L200:
/* on the first iteration, adjust the initial step bound. */ /* on the first iteration, adjust the initial step bound. */
if (iter == 1) { if (iter == 1)
delta = std::min(delta,pnorm); delta = std::min(delta,pnorm);
}
/* evaluate the function at x + p and calculate its norm. */ /* evaluate the function at x + p and calculate its norm. */
iflag = Functor::f(wa2, wa4); iflag = Functor::f(wa2, wa4);
++nfev; ++nfev;
if (iflag < 0) { if (iflag < 0)
goto L300; goto L300;
}
fnorm1 = wa4.stableNorm(); fnorm1 = wa4.stableNorm();
/* compute the scaled actual reduction. */ /* compute the scaled actual reduction. */
@ -231,11 +196,8 @@ L200:
for (j = 0; j < n; ++j) { for (j = 0; j < n; ++j) {
l = ipvt[j]; l = ipvt[j];
temp = wa1[l]; temp = wa1[l];
for (i = 0; i <= j; ++i) { for (i = 0; i <= j; ++i)
wa3[i] += fjac(i,j) * temp; wa3[i] += fjac(i,j) * temp;
/* L220: */
}
/* L230: */
} }
temp1 = ei_abs2(wa3.stableNorm() / fnorm); temp1 = ei_abs2(wa3.stableNorm() / fnorm);
temp2 = ei_abs2(ei_sqrt(par) * pnorm / fnorm); temp2 = ei_abs2(ei_sqrt(par) * pnorm / fnorm);
@ -247,106 +209,72 @@ L200:
/* reduction. */ /* reduction. */
ratio = 0.; ratio = 0.;
if (prered != 0.) { if (prered != 0.)
ratio = actred / prered; ratio = actred / prered;
}
/* update the step bound. */ /* update the step bound. */
if (ratio > Scalar(.25)) { if (ratio <= Scalar(.25)) {
goto L240; if (actred >= 0.)
}
if (actred >= 0.) {
temp = Scalar(.5); temp = Scalar(.5);
} if (actred < 0.)
if (actred < 0.) {
temp = Scalar(.5) * dirder / (dirder + Scalar(.5) * actred); temp = Scalar(.5) * dirder / (dirder + Scalar(.5) * actred);
}
if (Scalar(.1) * fnorm1 >= fnorm || temp < Scalar(.1)) if (Scalar(.1) * fnorm1 >= fnorm || temp < Scalar(.1))
temp = Scalar(.1); temp = Scalar(.1);
/* Computing MIN */ /* Computing MIN */
delta = temp * std::min(delta, pnorm / Scalar(.1)); delta = temp * std::min(delta, pnorm / Scalar(.1));
par /= temp; par /= temp;
goto L260; } else if (!(par != 0. && ratio < Scalar(.75))) {
L240:
if (par != 0. && ratio < Scalar(.75)) {
goto L250;
}
delta = pnorm / Scalar(.5); delta = pnorm / Scalar(.5);
par = Scalar(.5) * par; par = Scalar(.5) * par;
L250: }
L260:
/* test for successful iteration. */ /* test for successful iteration. */
if (ratio < Scalar(1e-4)) { if (ratio >= Scalar(1e-4)) {
goto L290;
}
/* successful iteration. update x, fvec, and their norms. */ /* successful iteration. update x, fvec, and their norms. */
x = wa2; x = wa2;
wa2 = diag.cwise() * x; wa2 = diag.cwise() * x;
fvec = wa4; fvec = wa4;
xnorm = wa2.stableNorm(); xnorm = wa2.stableNorm();
fnorm = fnorm1; fnorm = fnorm1;
++iter; ++iter;
L290: }
/* tests for convergence. */ /* tests for convergence. */
if (ei_abs(actred) <= ftol && prered <= ftol && Scalar(.5) * ratio <= 1.) { if (ei_abs(actred) <= ftol && prered <= ftol && Scalar(.5) * ratio <= 1.)
info = 1; info = 1;
} if (delta <= xtol * xnorm)
if (delta <= xtol * xnorm) {
info = 2; info = 2;
} if (ei_abs(actred) <= ftol && prered <= ftol && Scalar(.5) * ratio <= 1. && info == 2)
if (ei_abs(actred) <= ftol && prered <= ftol && Scalar(.5) * ratio <= 1. && info
== 2) {
info = 3; info = 3;
} if (info != 0)
if (info != 0) {
goto L300; goto L300;
}
/* tests for termination and stringent tolerances. */ /* tests for termination and stringent tolerances. */
if (nfev >= maxfev) { if (nfev >= maxfev)
info = 5; info = 5;
} if (ei_abs(actred) <= epsilon<Scalar>() && prered <= epsilon<Scalar>() && Scalar(.5) * ratio <= 1.)
if (ei_abs(actred) <= epsilon<Scalar>() && prered <= epsilon<Scalar>() && Scalar(.5) * ratio <= 1.) {
info = 6; info = 6;
} if (delta <= epsilon<Scalar>() * xnorm)
if (delta <= epsilon<Scalar>() * xnorm) {
info = 7; info = 7;
} if (gnorm <= epsilon<Scalar>())
if (gnorm <= epsilon<Scalar>()) {
info = 8; info = 8;
} if (info != 0)
if (info != 0) {
goto L300; goto L300;
}
/* end of the inner loop. repeat if iteration unsuccessful. */ /* end of the inner loop. repeat if iteration unsuccessful. */
} while (ratio < Scalar(1e-4));
if (ratio < Scalar(1e-4)) {
goto L200;
}
/* end of the outer loop. */ /* end of the outer loop. */
}
goto L30;
L300: L300:
/* termination, either normal or user imposed. */ /* termination, either normal or user imposed. */
if (iflag < 0)
if (iflag < 0) {
info = iflag; info = iflag;
} if (nprint > 0)
iflag = 0;
if (nprint > 0) {
iflag = Functor::debug(x, fvec); iflag = Functor::debug(x, fvec);
}
return info; return info;
} }

View File

@ -46,22 +46,19 @@ int ei_lmstr(
/* check the input parameters for errors. */ /* check the input parameters for errors. */
if (n <= 0 || m < n || ftol < 0. || xtol < 0. || if (n <= 0 || m < n || ftol < 0. || xtol < 0. || gtol < 0. || maxfev <= 0 || factor <= 0.)
gtol < 0. || maxfev <= 0 || factor <= 0.) {
goto L340; goto L340;
}
if (mode == 2) if (mode == 2)
for (j = 0; j < n; ++j) for (j = 0; j < n; ++j)
if (diag[j] <= 0.) goto L300; if (diag[j] <= 0.) goto L340;
/* evaluate the function at the starting point */ /* evaluate the function at the starting point */
/* and calculate its norm. */ /* and calculate its norm. */
iflag = Functor::f(x, fvec); iflag = Functor::f(x, fvec);
nfev = 1; nfev = 1;
if (iflag < 0) { if (iflag < 0)
goto L340; goto L340;
}
fnorm = fvec.stableNorm(); fnorm = fvec.stableNorm();
/* initialize levenberg-marquardt parameter and iteration counter. */ /* initialize levenberg-marquardt parameter and iteration counter. */
@ -71,21 +68,17 @@ int ei_lmstr(
/* beginning of the outer loop. */ /* beginning of the outer loop. */
L30: while (true) {
/* if requested, call Functor::f to enable printing of iterates. */ /* if requested, call Functor::f to enable printing of iterates. */
if (nprint <= 0) { if (nprint > 0) {
goto L40;
}
iflag = 0; iflag = 0;
if ((iter - 1) % nprint == 0) { if ((iter - 1) % nprint == 0)
iflag = Functor::debug(x, fvec, wa3); iflag = Functor::debug(x, fvec, wa3);
if (iflag < 0)
break;
} }
if (iflag < 0) {
goto L340;
}
L40:
/* compute the qr factorization of the jacobian matrix */ /* compute the qr factorization of the jacobian matrix */
/* calculated one row at a time, while simultaneously */ /* calculated one row at a time, while simultaneously */
@ -97,7 +90,7 @@ L40:
iflag = 2; iflag = 2;
for (i = 0; i < m; ++i) { for (i = 0; i < m; ++i) {
if (Functor::df(x, wa3, iflag) < 0) if (Functor::df(x, wa3, iflag) < 0)
goto L340; break;
temp = fvec[i]; temp = fvec[i];
ei_rwupdt<Scalar>(n, fjac.data(), fjac.rows(), wa3.data(), qtf.data(), &temp, wa1.data(), wa2.data()); ei_rwupdt<Scalar>(n, fjac.data(), fjac.rows(), wa3.data(), qtf.data(), &temp, wa1.data(), wa2.data());
++iflag; ++iflag;
@ -115,45 +108,33 @@ L40:
ipvt[j] = j; ipvt[j] = j;
wa2[j] = fjac.col(j).start(j).stableNorm(); wa2[j] = fjac.col(j).start(j).stableNorm();
} }
if (! sing) if (sing) {
goto L130;
ipvt.cwise()+=1; ipvt.cwise()+=1;
ei_qrfac<Scalar>(n, n, fjac.data(), fjac.rows(), true, ipvt.data(), n, wa1.data(), wa2.data()); ei_qrfac<Scalar>(n, n, fjac.data(), fjac.rows(), true, ipvt.data(), n, wa1.data(), wa2.data());
ipvt.cwise()-=1; // qrfac() creates ipvt with fortran convetion (1->n), convert it to c (0->n-1) ipvt.cwise()-=1; // qrfac() creates ipvt with fortran convetion (1->n), convert it to c (0->n-1)
for (j = 0; j < n; ++j) { for (j = 0; j < n; ++j) {
if (fjac(j,j) == 0.) if (fjac(j,j) != 0.) {
goto L110;
sum = 0.; sum = 0.;
for (i = j; i < n; ++i) { for (i = j; i < n; ++i)
sum += fjac(i,j) * qtf[i]; sum += fjac(i,j) * qtf[i];
}
temp = -sum / fjac(j,j); temp = -sum / fjac(j,j);
for (i = j; i < n; ++i) { for (i = j; i < n; ++i)
qtf[i] += fjac(i,j) * temp; qtf[i] += fjac(i,j) * temp;
} }
L110:
fjac(j,j) = wa1[j]; fjac(j,j) = wa1[j];
/* L120: */
} }
L130: }
/* on the first iteration and if mode is 1, scale according */ /* on the first iteration and if mode is 1, scale according */
/* to the norms of the columns of the initial jacobian. */ /* to the norms of the columns of the initial jacobian. */
if (iter != 1) { if (iter == 1) {
goto L170; if (mode != 2)
}
if (mode == 2) {
goto L150;
}
for (j = 0; j < n; ++j) { for (j = 0; j < n; ++j) {
diag[j] = wa2[j]; diag[j] = wa2[j];
if (wa2[j] == 0.) { if (wa2[j] == 0.)
diag[j] = 1.; diag[j] = 1.;
} }
/* L140: */
}
L150:
/* on the first iteration, calculate the norm of the scaled x */ /* on the first iteration, calculate the norm of the scaled x */
/* and initialize the step bound delta. */ /* and initialize the step bound delta. */
@ -161,17 +142,14 @@ L150:
wa3 = diag.cwise() * x; wa3 = diag.cwise() * x;
xnorm = wa3.stableNorm(); xnorm = wa3.stableNorm();
delta = factor * xnorm; delta = factor * xnorm;
if (delta == 0.) { if (delta == 0.)
delta = factor; delta = factor;
} }
L170:
/* compute the norm of the scaled gradient. */ /* compute the norm of the scaled gradient. */
gnorm = 0.; gnorm = 0.;
if (fnorm == 0.) { if (fnorm != 0.)
goto L210;
}
for (j = 0; j < n; ++j) { for (j = 0; j < n; ++j) {
l = ipvt[j]; l = ipvt[j];
if (wa2[l] != 0.) { if (wa2[l] != 0.) {
@ -182,29 +160,21 @@ L170:
gnorm = std::max(gnorm, ei_abs(sum / wa2[l])); gnorm = std::max(gnorm, ei_abs(sum / wa2[l]));
} }
} }
L210:
/* test for convergence of the gradient norm. */ /* test for convergence of the gradient norm. */
if (gnorm <= gtol) { if (gnorm <= gtol)
info = 4; info = 4;
} if (info != 0)
if (info != 0) { break;
goto L340;
}
/* rescale if necessary. */ /* rescale if necessary. */
if (mode == 2) { if (mode != 2) /* Computing MAX */
goto L230;
}
/* Computing MAX */
diag = diag.cwise().max(wa2); diag = diag.cwise().max(wa2);
L230:
/* beginning of the inner loop. */ /* beginning of the inner loop. */
do {
L240:
/* determine the levenberg-marquardt parameter. */ /* determine the levenberg-marquardt parameter. */
@ -219,17 +189,15 @@ L240:
/* on the first iteration, adjust the initial step bound. */ /* on the first iteration, adjust the initial step bound. */
if (iter == 1) { if (iter == 1)
delta = std::min(delta,pnorm); delta = std::min(delta,pnorm);
}
/* evaluate the function at x + p and calculate its norm. */ /* evaluate the function at x + p and calculate its norm. */
iflag = Functor::f(wa2, wa4); iflag = Functor::f(wa2, wa4);
++nfev; ++nfev;
if (iflag < 0) { if (iflag < 0)
goto L340; goto L340;
}
fnorm1 = wa4.stableNorm(); fnorm1 = wa4.stableNorm();
/* compute the scaled actual reduction. */ /* compute the scaled actual reduction. */
@ -245,11 +213,8 @@ L240:
for (j = 0; j < n; ++j) { for (j = 0; j < n; ++j) {
l = ipvt[j]; l = ipvt[j];
temp = wa1[l]; temp = wa1[l];
for (i = 0; i <= j; ++i) { for (i = 0; i <= j; ++i)
wa3[i] += fjac(i,j) * temp; wa3[i] += fjac(i,j) * temp;
/* L260: */
}
/* L270: */
} }
temp1 = ei_abs2(wa3.stableNorm() / fnorm); temp1 = ei_abs2(wa3.stableNorm() / fnorm);
temp2 = ei_abs2(ei_sqrt(par) * pnorm / fnorm); temp2 = ei_abs2(ei_sqrt(par) * pnorm / fnorm);
@ -261,107 +226,72 @@ L240:
/* reduction. */ /* reduction. */
ratio = 0.; ratio = 0.;
if (prered != 0.) { if (prered != 0.)
ratio = actred / prered; ratio = actred / prered;
}
/* update the step bound. */ /* update the step bound. */
if (ratio > Scalar(.25)) { if (ratio <= Scalar(.25)) {
goto L280; if (actred >= 0.)
}
if (actred >= 0.) {
temp = Scalar(.5); temp = Scalar(.5);
} if (actred < 0.)
if (actred < 0.) {
temp = Scalar(.5) * dirder / (dirder + Scalar(.5) * actred); temp = Scalar(.5) * dirder / (dirder + Scalar(.5) * actred);
}
if (Scalar(.1) * fnorm1 >= fnorm || temp < Scalar(.1)) if (Scalar(.1) * fnorm1 >= fnorm || temp < Scalar(.1))
temp = Scalar(.1); temp = Scalar(.1);
/* Computing MIN */ /* Computing MIN */
delta = temp * std::min(delta, pnorm / Scalar(.1)); delta = temp * std::min(delta, pnorm / Scalar(.1));
par /= temp; par /= temp;
goto L300; } else if (!(par != 0. && ratio < Scalar(.75))) {
L280:
if (par != 0. && ratio < Scalar(.75)) {
goto L290;
}
delta = pnorm / Scalar(.5); delta = pnorm / Scalar(.5);
par = Scalar(.5) * par; par = Scalar(.5) * par;
L290: }
L300:
/* test for successful iteration. */ /* test for successful iteration. */
if (ratio < Scalar(1e-4)) { if (ratio >= Scalar(1e-4)) {
goto L330;
}
/* successful iteration. update x, fvec, and their norms. */ /* successful iteration. update x, fvec, and their norms. */
x = wa2; x = wa2;
wa2 = diag.cwise() * x; wa2 = diag.cwise() * x;
fvec = wa4; fvec = wa4;
xnorm = wa2.stableNorm(); xnorm = wa2.stableNorm();
fnorm = fnorm1; fnorm = fnorm1;
++iter; ++iter;
L330: }
/* tests for convergence. */ /* tests for convergence. */
if (ei_abs(actred) <= ftol && prered <= ftol && Scalar(.5) * ratio <= 1.) { if (ei_abs(actred) <= ftol && prered <= ftol && Scalar(.5) * ratio <= 1.)
info = 1; info = 1;
} if (delta <= xtol * xnorm)
if (delta <= xtol * xnorm) {
info = 2; info = 2;
} if (ei_abs(actred) <= ftol && prered <= ftol && Scalar(.5) * ratio <= 1. && info == 2)
if (ei_abs(actred) <= ftol && prered <= ftol && Scalar(.5) * ratio <= 1. && info
== 2) {
info = 3; info = 3;
} if (info != 0)
if (info != 0) {
goto L340; goto L340;
}
/* tests for termination and stringent tolerances. */ /* tests for termination and stringent tolerances. */
if (nfev >= maxfev) { if (nfev >= maxfev)
info = 5; info = 5;
} if (ei_abs(actred) <= epsilon<Scalar>() && prered <= epsilon<Scalar>() && Scalar(.5) * ratio <= 1.)
if (ei_abs(actred) <= epsilon<Scalar>() && prered <= epsilon<Scalar>() && Scalar(.5) * ratio <= 1.) {
info = 6; info = 6;
} if (delta <= epsilon<Scalar>() * xnorm)
if (delta <= epsilon<Scalar>() * xnorm) {
info = 7; info = 7;
} if (gnorm <= epsilon<Scalar>())
if (gnorm <= epsilon<Scalar>()) {
info = 8; info = 8;
} if (info != 0)
if (info != 0) {
goto L340; goto L340;
}
/* end of the inner loop. repeat if iteration unsuccessful. */ /* end of the inner loop. repeat if iteration unsuccessful. */
} while (ratio < Scalar(1e-4));
if (ratio < Scalar(1e-4)) {
goto L240;
}
/* end of the outer loop. */ /* end of the outer loop. */
}
goto L30;
L340: L340:
/* termination, either normal or user imposed. */ /* termination, either normal or user imposed. */
if (iflag < 0)
if (iflag < 0) {
info = iflag; info = iflag;
} if (nprint > 0)
iflag = 0;
if (nprint > 0) {
iflag = Functor::debug(x, fvec, wa3); iflag = Functor::debug(x, fvec, wa3);
}
return info; return info;
} }