Home
last modified time | relevance | path

Searched refs:jac (Results 1 – 25 of 1707) sorted by relevance

12345678910>>...69

/dports/science/PETSc/petsc-3.14.1/src/ksp/pc/impls/hypre/
H A Dhypre.c283 …if (!jac->coords[0] && !jac->constants[0] && !(jac->ND_PiFull || (jac->ND_Pi[0] && jac->ND_Pi[1]))… in PCSetUp_HYPRE()
324 if (jac->ND_PiFull || (jac->ND_Pi[0] && jac->ND_Pi[1])) { in PCSetUp_HYPRE()
348 …if (!jac->coords[0] && !((jac->RT_PiFull || (jac->RT_Pi[0] && jac->RT_Pi[1])) && (jac->ND_PiFull |… in PCSetUp_HYPRE()
370 …if ((jac->RT_PiFull || (jac->RT_Pi[0] && jac->RT_Pi[1])) && (jac->ND_PiFull || (jac->ND_Pi[0] && j… in PCSetUp_HYPRE()
467 …if (jac->coords[0]) PetscStackCallStandard(HYPRE_IJVectorDestroy,(jac->coords[0])); jac->coords[0]… in PCReset_HYPRE()
475 jac->dim = 0; in PCReset_HYPRE()
486 if (jac->destroy) PetscStackCallStandard(jac->destroy,(jac->hsolver)); in PCDestroy_HYPRE()
808 jac->relaxtype[0] = jac->relaxtype[1] = indx; in PCSetFromOptions_HYPRE_BoomerAMG()
1029 …if (flag) PetscStackCallStandard(HYPRE_ParaSailsSetParams,(jac->hsolver,jac->threshold,jac->nlevel… in PCSetFromOptions_HYPRE_ParaSails()
1760 PetscStackCallStandard(HYPRE_ParaSailsSetParams,(jac->hsolver,jac->threshold,jac->nlevels)); in PCHYPRESetType_HYPRE()
[all …]
/dports/math/py-levmar/levmar-0.2.3/levmar/levmar-2.6/
H A Dlmdemo.c91 jac[j++]=0.0; in jacmodros()
93 jac[j++]=0.0; in jacmodros()
94 jac[j++]=0.0; in jacmodros()
159 jac[j++]=tmp; in jacmeyer()
229 jac[i++]=0.0; in jachelval()
231 jac[i++]=0.0; in jachelval()
232 jac[i++]=0.0; in jachelval()
233 jac[i++]=1.0; in jachelval()
714 jac[j+4]=-3; in jaccombust()
721 jac[j+4]=-R; in jaccombust()
[all …]
/dports/math/levmar/levmar-2.6/
H A Dlmdemo.c91 jac[j++]=0.0; in jacmodros()
93 jac[j++]=0.0; in jacmodros()
94 jac[j++]=0.0; in jacmodros()
159 jac[j++]=tmp; in jacmeyer()
229 jac[i++]=0.0; in jachelval()
231 jac[i++]=0.0; in jachelval()
232 jac[i++]=0.0; in jachelval()
233 jac[i++]=1.0; in jachelval()
714 jac[j+4]=-3; in jaccombust()
721 jac[j+4]=-R; in jaccombust()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/snes/impls/composite/
H A Dsnescomposite.c260 jac->h[i + j*jac->n] = jac->h[j + i*jac->n]; in SNESCompositeApply_AdditiveOptimal()
266 jac->h[i + j*jac->n] = jac->h[i + j*jac->n] - jac->g[j] - jac->g[i] + ftf; in SNESCompositeApply_AdditiveOptimal()
268 jac->beta[i] = ftf - jac->g[i]; in SNESCompositeApply_AdditiveOptimal()
275 …ACKgelss_(&jac->n,&jac->n,&jac->nrhs,jac->h,&jac->lda,jac->beta,&jac->lda,jac->s,&jac->rcond,&jac-… in SNESCompositeApply_AdditiveOptimal()
277 …s",LAPACKgelss_(&jac->n,&jac->n,&jac->nrhs,jac->h,&jac->lda,jac->beta,&jac->lda,jac->s,&jac->rcond… in SNESCompositeApply_AdditiveOptimal()
369 jac->lda = jac->nsnes; in SNESSetUp_Composite()
370 jac->ldb = jac->nsnes; in SNESSetUp_Composite()
371 jac->n = jac->nsnes; in SNESSetUp_Composite()
373 ierr = PetscMalloc1(jac->n*jac->n,&jac->h);CHKERRQ(ierr); in SNESSetUp_Composite()
377 jac->lwork = 12*jac->n; in SNESSetUp_Composite()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/ksp/pc/impls/svd/
H A Dsvd.c57 ierr = MatCreateVecs(jac->A,&jac->diag,&jac->work);CHKERRQ(ierr); in PCSetUp_SVD()
59 if (!jac->U) { in PCSetUp_SVD()
60 ierr = MatDuplicate(jac->A,MAT_DO_NOT_COPY_VALUES,&jac->U);CHKERRQ(ierr); in PCSetUp_SVD()
61 ierr = MatDuplicate(jac->A,MAT_DO_NOT_COPY_VALUES,&jac->Vt);CHKERRQ(ierr); in PCSetUp_SVD()
102 jac->nzero = n-1-i; in PCSetUp_SVD()
103 if (jac->monitor) { in PCSetUp_SVD()
129 …if (jac->essrank > 0) for (i=0; i<n-jac->nzero-jac->essrank; i++) d[i] = 0.0; /* Skip all but essr… in PCSetUp_SVD()
160 … if (!jac->left2red) {ierr = VecScatterCreateToAll(x,&jac->left2red,&jac->leftred);CHKERRQ(ierr);} in PCSVDGetVec()
171 …if (!jac->right2red) {ierr = VecScatterCreateToAll(x,&jac->right2red,&jac->rightred);CHKERRQ(ierr)… in PCSVDGetVec()
373 PC_SVD *jac; in PCCreate_SVD() local
[all …]
/dports/cad/meshlab/meshlab-Meshlab-2020.05/src/external/levmar-2.3/
H A Dlmdemo.c91 jac[j++]=0.0; in jacmodros()
93 jac[j++]=0.0; in jacmodros()
94 jac[j++]=0.0; in jacmodros()
159 jac[j++]=tmp; in jacmeyer()
199 jac[i++]=0.0; in jachelval()
201 jac[i++]=0.0; in jachelval()
202 jac[i++]=0.0; in jachelval()
203 jac[i++]=1.0; in jachelval()
630 jac[j+4]=-3; in jaccombust()
637 jac[j+4]=-R; in jaccombust()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/ksp/pc/impls/galerkin/
H A Dgalerkin.c22 if (jac->R) { in PCApply_Galerkin()
23 ierr = MatRestrict(jac->R,x,jac->b);CHKERRQ(ierr); in PCApply_Galerkin()
25 ierr = MatRestrict(jac->P,x,jac->b);CHKERRQ(ierr); in PCApply_Galerkin()
27 ierr = KSPSolve(jac->ksp,jac->b,jac->x);CHKERRQ(ierr); in PCApply_Galerkin()
28 ierr = KSPCheckSolve(jac->ksp,pc,jac->x);CHKERRQ(ierr); in PCApply_Galerkin()
29 if (jac->P) { in PCApply_Galerkin()
30 ierr = MatInterpolate(jac->P,jac->x,y);CHKERRQ(ierr); in PCApply_Galerkin()
32 ierr = MatInterpolate(jac->R,jac->x,y);CHKERRQ(ierr); in PCApply_Galerkin()
57 if (!jac->x) { in PCSetUp_Galerkin()
131 jac->R = R; in PCGalerkinSetRestriction_Galerkin()
[all …]
/dports/graphics/mirtk/MIRTK-2.0.0-122-g38210fa/Modules/Transformation/src/
H A DLinearElasticityConstraint.cc220 Reorient(jac(0, 0), jac(0, 1), jac(0, 2)); in operator ()()
221 Reorient(jac(1, 0), jac(1, 1), jac(1, 2)); in operator ()()
222 Reorient(jac(2, 0), jac(2, 1), jac(2, 2)); in operator ()()
224 Reorient(jac(0, 0), jac(0, 1)); in operator ()()
225 Reorient(jac(1, 0), jac(1, 1)); in operator ()()
318 b = jac(0, 0) + jac(1, 1) + jac(2, 2); in operator ()()
380 b = jac(0, 0) + jac(1, 1) + jac(2, 2); in operator ()()
483 div = jac(0, 0) + jac(1, 1) + jac(2, 2); in operator ()()
505 div = jac(0, 0) + jac(1, 1) + jac(2, 2); in operator ()()
603 div = jac(0, 0) + jac(1, 1) + jac(2, 2); in operator ()()
[all …]
H A DInverseAffineTransformation.cc141 jac[1] = .0; in JacobianDOFs()
142 jac[2] = .0; in JacobianDOFs()
144 jac[0] = .0; in JacobianDOFs()
146 jac[2] = .0; in JacobianDOFs()
148 jac[0] = .0; in JacobianDOFs()
168 jac[0] *= rad_per_deg, jac[1] *= rad_per_deg, jac[2] *= rad_per_deg; in JacobianDOFs()
179 jac[0] *= rad_per_deg, jac[1] *= rad_per_deg, jac[2] *= rad_per_deg; in JacobianDOFs()
190 jac[0] *= rad_per_deg, jac[1] *= rad_per_deg, jac[2] *= rad_per_deg; in JacobianDOFs()
203 mul(m, jac); in JacobianDOFs()
225 mul(m, jac); in JacobianDOFs()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/ksp/pc/impls/fieldsplit/
H A Dfieldsplit.c85 return jac->schur_user ? jac->schur_user : jac->pmat[1]; in FieldSplitSchurPre()
227 if (jac->head && jac->kspupper != jac->head->ksp) { in PCView_FieldSplit_Schur()
270 if (jac->kspupper != jac->head->ksp) { in PCView_FieldSplit_Schur()
743 jac->mat = jac->pmat; in PCSetUp_FieldSplit()
862 …ierr = MatSchurComplementUpdateSubMatrices(jac->schur,jac->mat[0],jac->pmat[0],jac->B,jac->C,jac-… in PCSetUp_FieldSplit()
903 …ierr = MatSchurComplementSetSubMatrices(jac->schur,jac->mat[0],jac->pmat[0],jac->B,jac->C,jac->mat… in PCSetUp_FieldSplit()
989 jac->kspupper = jac->head->ksp; in PCSetUp_FieldSplit()
1070 …ierr = MatGolubKahanComputeExplicitOperator(jac->mat[0],jac->B,jac->C,&jac->H,jac->gkbnu);CHKERRQ(… in PCSetUp_FieldSplit()
1559 if (jac->mat && jac->mat != jac->pmat) { in PCReset_FieldSplit()
1727 nn = jac->nsplits + (jac->kspupper != jac->head->ksp ? 1 : 0); in PCFieldSplitSchurGetSubKSP_FieldSplit()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/ksp/pc/impls/bjacobi/
H A Dbjacobi.c29 if (jac->n > 0 && jac->n < size) { in PCSetUp_BJacobi()
39 if (jac->n_local > 0 && jac->n < 0) { in PCSetUp_BJacobi()
50 …for (i=0; i<jac->n_local; i++) jac->l_lens[i] = bs*((M/bs)/jac->n_local + (((M/bs) % jac->n_local)… in PCSetUp_BJacobi()
61 jac->n_local = jac->n; in PCSetUp_BJacobi()
63 ierr = PetscArraycpy(jac->l_lens,jac->g_lens,jac->n_local);CHKERRQ(ierr); in PCSetUp_BJacobi()
74 if (i < jac->n) sum += jac->g_lens[i]; in PCSetUp_BJacobi()
80 if (i < jac->n) sum += jac->g_lens[i]; in PCSetUp_BJacobi()
89 jac->n_local = jac->n/size + ((jac->n % size) > rank); in PCSetUp_BJacobi()
92 jac->l_lens[i] = ((M/bs)/jac->n_local + (((M/bs) % jac->n_local) > i))*bs; in PCSetUp_BJacobi()
104 …for (i=0; i<jac->n_local; i++) jac->l_lens[i] = bs*((M/bs)/jac->n_local + (((M/bs) % jac->n_local)… in PCSetUp_BJacobi()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/ksp/pc/impls/composite/
H A Dcomposite.c39 next = jac->head; in PCApply_Composite_Multiplicative()
42 ierr = VecDuplicate(jac->work1,&jac->work2);CHKERRQ(ierr); in PCApply_Composite_Multiplicative()
57 ierr = VecWAXPY(jac->work2,-1.0,jac->work1,x);CHKERRQ(ierr); in PCApply_Composite_Multiplicative()
58 ierr = PCApply(next->pc,jac->work2,jac->work1);CHKERRQ(ierr); in PCApply_Composite_Multiplicative()
75 ierr = VecDuplicate(jac->work1,&jac->work2);CHKERRQ(ierr); in PCApplyTranspose_Composite_Multiplicative()
86 ierr = VecWAXPY(jac->work2,-1.0,jac->work1,x);CHKERRQ(ierr); in PCApplyTranspose_Composite_Multiplicative()
91 next = jac->head; in PCApplyTranspose_Composite_Multiplicative()
95 ierr = VecWAXPY(jac->work2,-1.0,jac->work1,x);CHKERRQ(ierr); in PCApplyTranspose_Composite_Multiplicative()
141 next = jac->head; in PCApply_Composite_Additive()
251 next = jac->head; in PCSetFromOptions_Composite()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/ksp/pc/impls/ksp/
H A Dpcksp.c39 if (jac->ksp->presolve) { in PCApply_KSP()
47 jac->its += its; in PCApply_KSP()
58 if (jac->ksp->presolve) { in PCMatApply_KSP()
66 jac->its += its; in PCMatApply_KSP()
85 jac->its += its; in PCApplyTranspose_KSP()
96 if (!jac->ksp) { in PCSetUp_KSP()
164 jac->ksp = ksp; in PCKSPSetKSP_KSP()
202 *ksp = jac->ksp; in PCKSPGetKSP_KSP()
243 if (jac->ksp) { in PCSetFromOptions_KSP()
285 PC_KSP *jac; in PCCreate_KSP() local
[all …]
/dports/science/PETSc/petsc-3.14.1/src/ksp/pc/impls/sor/
H A Dsor.c30 …ierr = MatSOR(pc->pmat,x,jac->omega,(MatSORType)flag,jac->fshift,jac->its,jac->lits,y);CHKERRQ(ier… in PCApply_SOR()
45 …ierr = MatSOR(pc->pmat,x,jac->omega,(MatSORType)flag,jac->fshift,jac->its,jac->lits,y);CHKERRQ(ier… in PCApplyTranspose_SOR()
59 ierr = MatSOR(pc->pmat,b,jac->omega,stype,jac->fshift,its*jac->its,jac->lits,y);CHKERRQ(ierr); in PCApplyRichardson_SOR()
128 jac->sym = flag; in PCSORSetSymmetric_SOR()
138 jac->omega = omega; in PCSORSetOmega_SOR()
147 jac->its = its; in PCSORSetIterations_SOR()
148 jac->lits = lits; in PCSORSetIterations_SOR()
157 *flag = jac->sym; in PCSORGetSymmetric_SOR()
166 *omega = jac->omega; in PCSORGetOmega_SOR()
175 if (its) *its = jac->its; in PCSORGetIterations_SOR()
[all …]
/dports/www/grafana8/grafana-8.3.6/vendor/gonum.org/v1/gonum/diff/fd/
H A Djacobian_test.go21 jac.Set(0, 0, 5)
33 jac.Set(1, 0, 5)
44 jac.Set(0, 0, 1)
45 jac.Set(0, 1, 0)
46 jac.Set(0, 2, 0)
47 jac.Set(1, 0, 0)
48 jac.Set(1, 1, 0)
49 jac.Set(1, 2, 5)
50 jac.Set(2, 0, 0)
52 jac.Set(2, 2, -2)
[all …]
/dports/sysutils/istio/istio-1.6.7/vendor/github.com/openshift/api/vendor/gonum.org/v1/gonum/diff/fd/
H A Djacobian_test.go21 jac.Set(0, 0, 5)
33 jac.Set(1, 0, 5)
44 jac.Set(0, 0, 1)
45 jac.Set(0, 1, 0)
46 jac.Set(0, 2, 0)
47 jac.Set(1, 0, 0)
48 jac.Set(1, 1, 0)
49 jac.Set(1, 2, 5)
50 jac.Set(2, 0, 0)
52 jac.Set(2, 2, -2)
[all …]
/dports/graphics/mirtk/MIRTK-2.0.0-122-g38210fa/Modules/Image/src/
H A DScalingAndSquaring.cc156 return jac; in Jacobian()
349 … out[_x] = in[_x] + static_cast<TGradient>(jac(0, 0) * g[0] + jac(0, 1) * g[1] + jac(0, 2) * g[2]); in EvaluateGradient()
350 … out[_y] = in[_y] + static_cast<TGradient>(jac(1, 0) * g[0] + jac(1, 1) * g[1] + jac(1, 2) * g[2]); in EvaluateGradient()
351 … out[_z] = in[_z] + static_cast<TGradient>(jac(2, 0) * g[0] + jac(2, 1) * g[1] + jac(2, 2) * g[2]); in EvaluateGradient()
376 Matrix jac; in operator ()() local
416 Matrix jac; in operator ()() local
532 Matrix jac; in operator ()() local
544 Matrix jac; in operator ()() local
556 Matrix jac; in operator ()() local
570 Matrix jac; in operator ()() local
[all …]
/dports/misc/openmvg/openMVG-2.0/src/third_party/ceres-solver/internal/ceres/
H A Dcorrector_test.cc151 MatrixRef jac(jacobian, 3, 2); in TEST() local
195 g_hess = rho[1] * jac.transpose() * jac + in TEST()
196 2.0 * rho[2] * jac.transpose() * res * res.transpose() * jac; in TEST()
203 c_grad = jac.transpose() * res; in TEST()
204 c_hess = jac.transpose() * jac; in TEST()
219 MatrixRef jac(jacobian, 3, 2); in TEST() local
253 g_jac = sqrt(rho[1]) * jac; in TEST()
256 g_hess = rho[1] * jac.transpose() * jac + in TEST()
257 2.0 * rho[2] * jac.transpose() * res * res.transpose() * jac; in TEST()
264 c_grad = jac.transpose() * res; in TEST()
[all …]
/dports/math/ceres-solver/ceres-solver-2.0.0/internal/ceres/
H A Dcorrector_test.cc147 MatrixRef jac(jacobian, 3, 2); in TEST() local
186 sqrt(rho[1]) * (jac - kAlpha / sq_norm * res * res.transpose() * jac); in TEST()
189 g_hess = rho[1] * jac.transpose() * jac + in TEST()
190 2.0 * rho[2] * jac.transpose() * res * res.transpose() * jac; in TEST()
197 c_grad = jac.transpose() * res; in TEST()
198 c_hess = jac.transpose() * jac; in TEST()
213 MatrixRef jac(jacobian, 3, 2); in TEST() local
246 g_jac = sqrt(rho[1]) * jac; in TEST()
249 g_hess = rho[1] * jac.transpose() * jac + in TEST()
250 2.0 * rho[2] * jac.transpose() * res * res.transpose() * jac; in TEST()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/ksp/pc/impls/jacobi/
H A Djacobi.c161 diag = jac->diag; in PCSetUp_Jacobi()
162 diagsqrt = jac->diagsqrt; in PCSetUp_Jacobi()
165 if (jac->userowmax) { in PCSetUp_Jacobi()
175 if (jac->useabs) { in PCSetUp_Jacobi()
187 if (jac->userowmax) { in PCSetUp_Jacobi()
269 if (!jac->diag) { in PCApply_Jacobi()
295 if (!jac->diagsqrt) { in PCApplySymmetricLeftOrRight_Jacobi()
390 PC_Jacobi *jac; in PCCreate_Jacobi() local
399 pc->data = (void*)jac; in PCCreate_Jacobi()
405 jac->diag = NULL; in PCCreate_Jacobi()
[all …]
/dports/cad/gmsh/gmsh-4.9.2-source/Geo/
H A DMElement.cpp758 (jac[0][0] * jac[1][1] * jac[2][2] + jac[0][2] * jac[1][0] * jac[2][1] + in _computeDeterminantAndRegularize()
759 jac[0][1] * jac[1][2] * jac[2][0] - jac[0][2] * jac[1][1] * jac[2][0] - in _computeDeterminantAndRegularize()
760 jac[0][0] * jac[1][2] * jac[2][1] - jac[0][1] * jac[1][0] * jac[2][2]); in _computeDeterminantAndRegularize()
780 jac[0] = jac[4] = jac[8] = 1.0; in _computeDeterminantAndRegularize()
781 jac[1] = jac[2] = jac[3] = 0.0; in _computeDeterminantAndRegularize()
816 dJ = sqrt(SQU(jac[0] * jac[4] - jac[1] * jac[3]) + in _computeDeterminantAndRegularize()
817 SQU(jac[2] * jac[3] - jac[0] * jac[5]) + in _computeDeterminantAndRegularize()
818 SQU(jac[1] * jac[5] - jac[2] * jac[4])); in _computeDeterminantAndRegularize()
836 dJ = (jac[0] * jac[4] * jac[8] + jac[2] * jac[3] * jac[7] + in _computeDeterminantAndRegularize()
837 jac[1] * jac[5] * jac[6] - jac[2] * jac[4] * jac[6] - in _computeDeterminantAndRegularize()
[all …]
/dports/science/py-scipy/scipy-1.7.1/scipy/optimize/tests/
H A Dtest_least_squares.py152 def jac(self, p): member in ExponentialFittingProblem
407 res = least_squares(fun_trivial, 2.0, jac=jac,
412 res = least_squares(fun_trivial, 2.0, jac=jac,
421 res = least_squares(fun_2d_trivial, x0, jac=jac)
423 res = least_squares(fun_2d_trivial, x0, jac=jac,
426 res = least_squares(fun_2d_trivial, x0, jac=jac,
472 sparse.fun, sparse.x0, jac=sparse.jac,
475 dense.fun, dense.x0, jac=sparse.jac,
500 res_dense = least_squares(dense.fun, dense.x0, jac=dense.jac,
681 for jac in ['2-point', '3-point', 'cs', p.jac]:
[all …]
/dports/graphics/mirtk/MIRTK-2.0.0-122-g38210fa/Applications/src/
H A Devaluate-jacobian.cc194 jac = log(max(jac, _threshold)); in Jacobian()
199 jac = fabs(log(max(jac, _threshold))); in Jacobian()
207 return IsNaN(jac) ? _outside : jac; in Jacobian()
231 *out = 100.0 * jac; in operator ()()
282 double jac; in Run()
293 jac = fabs(log(max(jac, _threshold))); in Run()
297 jac *= 100.; in Run()
299 jac = _outside; in Run()
528 if (jac < min) min = jac; in main()
529 if (jac > max) max = jac; in main()
[all …]
/dports/science/py-scipy/scipy-1.7.1/scipy/optimize/
H A D_root.py166 if bool(jac):
168 jac = fun.derivative
170 jac = None
187 sol = _root_hybr(fun, x0, args=args, jac=jac, **options)
189 sol = _root_leastsq(fun, x0, args=args, jac=jac, **options)
191 _warn_jac_unused(jac, method)
196 _warn_jac_unused(jac, method)
197 sol = _root_nonlin_solve(fun, x0, args=args, jac=jac,
206 def _warn_jac_unused(jac, method): argument
207 if jac is not None:
[all …]
/dports/cad/gmsh/gmsh-4.9.2-source/Post/
H A DshapeFunctions.h68 jac[0][0] = jac[0][1] = jac[0][2] = 0.; in getJacobian()
69 jac[1][0] = jac[1][1] = jac[1][2] = 0.; in getJacobian()
70 jac[2][0] = jac[2][1] = jac[2][2] = 0.; in getJacobian()
87 jac[0][0] * jac[1][1] * jac[2][2] + jac[0][2] * jac[1][0] * jac[2][1] + in getJacobian()
88 jac[0][1] * jac[1][2] * jac[2][0] - jac[0][2] * jac[1][1] * jac[2][0] - in getJacobian()
89 jac[0][0] * jac[1][2] * jac[2][1] - jac[0][1] * jac[1][0] * jac[2][2]); in getJacobian()
114 std::pow(jac[0][0] * jac[1][1] - jac[0][1] * jac[1][0], 2) + in getJacobian()
115 std::pow(jac[0][2] * jac[1][0] - jac[0][0] * jac[1][2], 2) + in getJacobian()
116 std::pow(jac[0][1] * jac[1][2] - jac[0][2] * jac[1][1], 2)); in getJacobian()
150 return std::sqrt(std::pow(jac[0][0], 2) + std::pow(jac[0][1], 2) + in getJacobian()
[all …]

12345678910>>...69