Home
last modified time | relevance | path

Searched refs:dJ (Results 1 – 25 of 945) sorted by relevance

12345678910>>...38

/dports/science/tfel/tfel-3.4.0/include/TFEL/Math/Stensor/
H A DStensorConcept.ixx239 dJ[0] = s[1]*s[2];
240 dJ[1] = s[0]*s[2];
241 dJ[2] = s[0]*s[1];
256 dJ[0] = s[1]*s[2];
257 dJ[1] = s[0]*s[2];
258 dJ[2] = s[0]*s[1]-s[3]*s[3]/2;
259 dJ[3] = -s[3]*s[2];
280 dJ[0]=s[1]*s[2]-s[5]*s[5]*one_half;
283 dJ[3]=icste*s[4]*s[5]-s[2]*s[3];
284 dJ[4]=icste*s[3]*s[5]-s[1]*s[4];
[all …]
/dports/science/tfel-edf/tfel-3.2.1/include/TFEL/Math/Stensor/
H A DStensorConcept.ixx254 dJ[0] = s[1]*s[2];
255 dJ[1] = s[0]*s[2];
256 dJ[2] = s[0]*s[1];
273 dJ[0] = s[1]*s[2];
274 dJ[1] = s[0]*s[2];
275 dJ[2] = s[0]*s[1]-s[3]*s[3]/2;
276 dJ[3] = -s[3]*s[2];
297 dJ[0]=s[1]*s[2]-s[5]*s[5]*one_half;
300 dJ[3]=icste*s[4]*s[5]-s[2]*s[3];
301 dJ[4]=icste*s[3]*s[5]-s[1]*s[4];
[all …]
/dports/math/gismo/gismo-21.12.0/extensions/gsElasticity/
H A DgsVisitorMass.h94 for (short_t dJ = 0; dJ < dim; ++dJ) in localToGlobal() local
102 if (!system.colMapper(dJ).is_free_index(globalIndices[dJ].at(j))) in localToGlobal()
104 … globalElimJ = system.colMapper(dJ).global_to_bindex(globalIndices[dJ].at(j)); in localToGlobal()
105 … elimMat->coeffRef(globalI,elimSize+globalElimJ) += localMat(N_D*dI+i,N_D*dJ+j); in localToGlobal()
108 elimSize += eliminatedDofs[dJ].rows(); in localToGlobal()
H A DgsVisitorBiharmonic.h118 for (short_t dJ = 0; dJ < 2; ++dJ) in localToGlobal() local
126 if (!system.colMapper(dJ).is_free_index(globalIndices[dJ].at(j))) in localToGlobal()
128 … globalElimJ = system.colMapper(dJ).global_to_bindex(globalIndices[dJ].at(j)); in localToGlobal()
129 … elimMat->coeffRef(globalI,elimSize+globalElimJ) += localMat(N_M*dI+i,N_M*dJ+j); in localToGlobal()
132 elimSize += eliminatedDofs[dJ].rows(); in localToGlobal()
H A DgsVisitorLinearElasticity.h139 for (short_t dJ = 0; dJ < dim; ++dJ) in localToGlobal() local
147 if (!system.colMapper(dJ).is_free_index(globalIndices[dJ].at(j))) in localToGlobal()
149 … globalElimJ = system.colMapper(dJ).global_to_bindex(globalIndices[dJ].at(j)); in localToGlobal()
150 … elimMat->coeffRef(globalI,elimSize+globalElimJ) += localMat(N_D*dI+i,N_D*dJ+j); in localToGlobal()
153 elimSize += eliminatedDofs[dJ].rows(); in localToGlobal()
/dports/science/tfel-edf/tfel-3.2.1/tests/Math/stensor/
H A DComputeDeterminantDerivativeTest.cxx42 const auto dJ = (Jp-Jm)/(2*e); in getNumericalApproximation() local
43 r(j)=dJ; in getNumericalApproximation()
76 const auto dJ = tfel::math::computeDeterminantDerivative(s); in check() local
78 if(std::abs(dJ(i)-ndJ(i))>prec){ in check()
79 std::cout << "dJ : " << i << " " << dJ(i) << " " << ndJ(i) in check()
80 << " " << std::abs(dJ(i)-ndJ(i)) << std::endl; in check()
82 TFEL_TESTS_ASSERT(std::abs(dJ(i)-ndJ(i))<prec); in check()
H A DComputeDeviatorDeterminantDerivativeTest.cxx42 const auto dJ = (Jp-Jm)/(2*e); in getNumericalApproximation() local
43 r(j)=dJ; in getNumericalApproximation()
86 const auto dJ = computeDeviatorDeterminantDerivative(s); in check() local
88 if(std::abs(dJ(i)-ndJ(i))>prec){ in check()
89 std::cout << "dJ : " << i << " " << dJ(i) << " " << ndJ(i) in check()
90 << " " << std::abs(dJ(i)-ndJ(i)) << std::endl; in check()
92 TFEL_TESTS_ASSERT(std::abs(dJ(i)-ndJ(i))<prec); in check()
/dports/science/tfel/tfel-3.4.0/tests/Math/stensor/
H A DComputeDeterminantDerivativeTest.cxx42 const auto dJ = (Jp-Jm)/(2*e); in getNumericalApproximation() local
43 r(j)=dJ; in getNumericalApproximation()
76 const auto dJ = tfel::math::computeDeterminantDerivative(s); in check() local
78 if(std::abs(dJ(i)-ndJ(i))>prec){ in check()
79 std::cout << "dJ : " << i << " " << dJ(i) << " " << ndJ(i) in check()
80 << " " << std::abs(dJ(i)-ndJ(i)) << std::endl; in check()
82 TFEL_TESTS_ASSERT(std::abs(dJ(i)-ndJ(i))<prec); in check()
H A DComputeDeviatorDeterminantDerivativeTest.cxx42 const auto dJ = (Jp-Jm)/(2*e); in getNumericalApproximation() local
43 r(j)=dJ; in getNumericalApproximation()
86 const auto dJ = computeDeviatorDeterminantDerivative(s); in check() local
88 if(std::abs(dJ(i)-ndJ(i))>prec){ in check()
89 std::cout << "dJ : " << i << " " << dJ(i) << " " << ndJ(i) in check()
90 << " " << std::abs(dJ(i)-ndJ(i)) << std::endl; in check()
92 TFEL_TESTS_ASSERT(std::abs(dJ(i)-ndJ(i))<prec); in check()
/dports/math/octave-forge-level-set/level-set/inst/
H A Dso_step_armijo.m25 ## J(t) \le J(0) + t \tau \cdot dJ.
31 ## J(t) <= J(0) + t * tau * dJ.
99 if (dJ >= 0)
214 %!shared n, phi, baseData, d, f, dJ
233 %! dJ = -2 / curVol^2;
257 %! so_step_armijo (1, d, f, dJ, data);
261 %! so_step_armijo (1, d, f, dJ, data);
265 %! so_step_armijo (1, d, f, dJ, data);
269 %! so_step_armijo (1, d, f, dJ, data);
273 %! so_step_armijo (1, d, f, dJ, data);
[all …]
/dports/science/elmerfem/elmerfem-release-9.0/elmerice/Tests/InvMeth_AdjRobin/PROG/
H A DGradientValidation.f9046 REAL(KIND=dp) :: J,J0,h,dJ,dJd local
68 save J0,h,dJ
182 dJ=0._dp
184 dJ=dJ+xp(i)*g(i)
189 CALL MPI_ALLREDUCE(dJ,dJ,1,&
224 write(io,'(4(e15.8,2x))') h,abs(dJ-dJd)/abs(dJ),dJ,dJd
/dports/science/elmerfem/elmerfem-release-9.0/elmerice/examples/InverseMethods_OLD/src/
H A DGradientValidation.F9046 REAL(KIND=dp) :: J,J0,h,dJ,dJd local
68 save J0,h,dJ
199 dJ=0._dp
201 dJ=dJ+xp(i)*g(i)
206 CALL MPI_ALLREDUCE(dJ,dJ,1,&
250 write(io,'(4(e15.8,2x))') h,abs(dJ-dJd)/abs(dJ),dJ,dJd
/dports/cad/gmsh/gmsh-4.9.2-source/Numeric/
H A DGaussLegendreSimplex.cpp37 double *pt1, *pt2, *pt3, *wt1, *wt2, *wt3, dJ; in GaussLegendreTet() local
46 &(pts[index].pt[1]), &(pts[index].pt[2]), &dJ); in GaussLegendreTet()
47 pts[index++].weight = dJ * wt1[i] * wt2[j] * wt3[k]; in GaussLegendreTet()
58 double *pt1, *pt2, *wt1, *wt2, dJ; in GaussLegendreTri() local
65 quadToTri(pt1[i], pt2[j], &(pts[index].pt[0]), &(pts[index].pt[1]), &dJ); in GaussLegendreTri()
67 pts[index++].weight = dJ * wt1[i] * wt2[j]; in GaussLegendreTri()
/dports/math/freefem++/FreeFem-sources-4.6/src/femlib/
H A DCGNL.hpp6 R argmin(R rho,const DJ & dJ, KN_<R> &x,KN_<R> &h,KN_<R> &g,KN_<R> &w)
19 x += (ro-rold)* h; rold=ro; g=dJ*x;// dJ(x,g);
35 x += (ro-rold)* h; rold=ro; g=dJ*x;// dJ(x,g);
61 x += (ro-rold)* h; rold=ro; g=dJ*x;//dJ(x,g);
74 int NLCG(const DJ & dJ,const P & C,KN_<R> &x,const int nbitermax, double &eps,long kprint=100000000… in NLCG() argument
83 g=dJ*x;// dJ(x,g); in NLCG()
97 ro = argmin(ro,dJ,x,h,g,Ah); in NLCG()
/dports/math/freefem++/FreeFem-sources-4.6/src/Algo/
H A Dlgalgo.cpp62 Expression J, dJ, hJ; member in OptimAlgo::E_LCG
71 Expression J, dJ, hJ, theparame; member in OptimAlgo::E_LCG::lgNRJ
83 : tNRJ< PARAM, VECT, VMAT, REAL >(n), stack(s), J(JJ), dJ(dJJ), hJ(hJJ), theparame(t), in lgNRJ()
85 if (dJ) gg = new VECT(n); in lgNRJ()
102 if (dJ) { in Gradient()
103 *gg = GetAny< Kn_ >((*dJ)(stack)); in Gradient()
144 J = dJ = hJ = 0; in E_LCG()
148 dJ = to< Kn_ >(C_F0( in E_LCG()
180 lgNRJ nrj1(stack, n, theparam, J, dJ, hJ); in operator ( )()
181 if (!dJ) delta = new KN< double >(n); in operator ( )()
/dports/science/elmerfem/elmerfem-release-9.0/elmerice/Solvers/Adjoint/
H A DAdjoint_GradientValidation.F9099 REAL(KIND=dp) :: J,J0,h,dJ,dJd local
123 save J0,h,dJ
232 dJ=0._dp
233 dJ=SUM(xp(:)*g(:))
237 CALL MPI_ALLREDUCE(dJ,dJ,1,&
274 write(io,'(4(e15.8,2x))') h,abs(dJ-dJd)/abs(dJ),dJ,dJd
/dports/science/tfel-edf/tfel-3.2.1/tests/Material/
H A DOrthotropicPlasticityTest.cxx43 const auto dJ = (Jp-Jm)/(2*e); in getNumericalApproximation() local
44 r(j)=dJ; in getNumericalApproximation()
99 const auto dJ = tfel::material::computeJ3ODerivative(s,c); in test1() local
101 if(std::abs(dJ(i)-ndJ(i))>prec){ in test1()
102 std::cout << "dJ : " << i << " " << dJ(i) << " " << ndJ(i) in test1()
103 << " " << std::abs(dJ(i)-ndJ(i)) << std::endl; in test1()
105 TFEL_TESTS_ASSERT(std::abs(dJ(i)-ndJ(i))<prec); in test1()
H A DIsotropicPlasticityTest.cxx42 const auto dJ = (Jp-Jm)/(2*e); in getNumericalApproximation() local
43 r(j)=dJ; in getNumericalApproximation()
81 const auto dJ = tfel::material::computeJ3Derivative(s); in test1() local
83 if(std::abs(dJ(i)-ndJ(i))>prec){ in test1()
84 std::cout << "dJ : " << i << " " << dJ(i) << " " << ndJ(i) in test1()
85 << " " << std::abs(dJ(i)-ndJ(i)) << std::endl; in test1()
87 TFEL_TESTS_ASSERT(std::abs(dJ(i)-ndJ(i))<prec); in test1()
/dports/science/tfel/tfel-3.4.0/tests/Material/
H A DOrthotropicPlasticityTest.cxx43 const auto dJ = (Jp-Jm)/(2*e); in getNumericalApproximation() local
44 r(j)=dJ; in getNumericalApproximation()
99 const auto dJ = tfel::material::computeJ3ODerivative(s,c); in test1() local
101 if(std::abs(dJ(i)-ndJ(i))>prec){ in test1()
102 std::cout << "dJ : " << i << " " << dJ(i) << " " << ndJ(i) in test1()
103 << " " << std::abs(dJ(i)-ndJ(i)) << std::endl; in test1()
105 TFEL_TESTS_ASSERT(std::abs(dJ(i)-ndJ(i))<prec); in test1()
H A DIsotropicPlasticityTest.cxx42 const auto dJ = (Jp-Jm)/(2*e); in getNumericalApproximation() local
43 r(j)=dJ; in getNumericalApproximation()
81 const auto dJ = tfel::material::computeJ3Derivative(s); in test1() local
83 if(std::abs(dJ(i)-ndJ(i))>prec){ in test1()
84 std::cout << "dJ : " << i << " " << dJ(i) << " " << ndJ(i) in test1()
85 << " " << std::abs(dJ(i)-ndJ(i)) << std::endl; in test1()
87 TFEL_TESTS_ASSERT(std::abs(dJ(i)-ndJ(i))<prec); in test1()
/dports/graphics/mirtk/MIRTK-2.0.0-122-g38210fa/Modules/Transformation/include/mirtk/
H A DBSplineFreeFormTransformation3D.h282 void EvaluateJacobianDetDerivative(double dJ[3], const Matrix &adj, double a, double b, double c,
294 void EvaluateJacobianDetDerivative(double dJ[3], const Matrix &adj, int a, int b, int c,
309 void EvaluateJacobianDetDerivative(double dJ[3], const Matrix &adj,
324 void EvaluateJacobianDetDerivative(double dJ[3], const Matrix &adj, int cp,
385 virtual void FFDJacobianDetDerivative(double dJ[3], const Matrix &adj,
653 ::EvaluateJacobianDetDerivative(double dJ[3], const Matrix &adj, in EvaluateJacobianDetDerivative()
657 EvaluateJacobianDetDerivative(dJ, adj, x - i, y - j, z - k, wrt_world, use_spacing); in EvaluateJacobianDetDerivative()
662 ::EvaluateJacobianDetDerivative(double dJ[3], const Matrix &adj, in EvaluateJacobianDetDerivative()
668 EvaluateJacobianDetDerivative(dJ, adj, x - i, y - j, z - k, wrt_world, use_spacing); in EvaluateJacobianDetDerivative()
673 ::FFDJacobianDetDerivative(double dJ[3], const Matrix &adj, in FFDJacobianDetDerivative()
[all …]
/dports/science/tfel-edf/tfel-3.2.1/tests/Math/tensor/
H A DTensorComputeJacobianDerivativeTest.cxx90 auto dJ = computeDeterminantDerivative(s); in check() local
92 if(std::abs(dJ(i)-ndJ(i))>prec){ in check()
93 std::cout << "dJ : " << i << " " << dJ(i) << " " << ndJ(i) in check()
94 << " " << std::abs(dJ(i)-ndJ(i)) << std::endl; in check()
96 TFEL_TESTS_ASSERT(std::abs(dJ(i)-ndJ(i))<prec); in check()
/dports/science/tfel/tfel-3.4.0/tests/Math/tensor/
H A DTensorComputeJacobianDerivativeTest.cxx90 auto dJ = computeDeterminantDerivative(s); in check() local
92 if(std::abs(dJ(i)-ndJ(i))>prec){ in check()
93 std::cout << "dJ : " << i << " " << dJ(i) << " " << ndJ(i) in check()
94 << " " << std::abs(dJ(i)-ndJ(i)) << std::endl; in check()
96 TFEL_TESTS_ASSERT(std::abs(dJ(i)-ndJ(i))<prec); in check()
/dports/misc/visp/visp-3.4.0/tutorial/image/
H A Dmonkey.ppm4dJ�m"�dJ�gI�P,�P,�M1�M1�gV͍��gg�V:�V&�W�W�M1�M1�M1�gV�gV�gV�op�gV�mSvi8fZ8fZ8i������������ڎ�ڎ…
/dports/audio/padthv1-lv2/padthv1-padthv1_0_9_23/src/
H A Dpadthv1_formant.cpp189 const float dJ = (fJ - float(j)); // vowel morph fraction in reset_coeffs() local
209 coeff1.a0 += dJ * (coeff2.a0 - coeff1.a0); in reset_coeffs()
210 coeff1.b1 += dJ * (coeff2.b1 - coeff1.b1); in reset_coeffs()
211 coeff1.b2 += dJ * (coeff2.b2 - coeff1.b2); in reset_coeffs()

12345678910>>...38