Home
last modified time | relevance | path

Searched refs:mcoeff (Results 1 – 24 of 24) sorted by relevance

/dports/math/libqalculate/libqalculate-3.17.0/libqalculate/
H A DMathStructure-polynomial.cc309 mcoeff.clear(); in coefficient()
319 if(mcoeff.isZero()) mcoeff.set(1, 1, 0); in coefficient()
324 if(mcoeff.isZero()) mcoeff.set(1, 1, 0); in coefficient()
345 if(mcoeff.isZero()) mcoeff = (*mcur)[i3]; in coefficient()
356 if(mcoeff[mcoeff.size() - 1].isZero()) mcoeff[mcoeff.size() - 1] = (*mcur)[i3]; in coefficient()
357 else mcoeff[mcoeff.size() - 1].multiply((*mcur)[i3], true); in coefficient()
365 if(mcoeff.isZero()) mcoeff = *mcur; in coefficient()
369 if(mcoeff.isZero()) mcoeff = *mcur; in coefficient()
374 mcoeff.evalSort(); in coefficient()
521 MathStructure mcoeff; in get_symbol_stats() local
[all …]
H A DMathStructure-isolatex.cc108 mcoeff = m; in find_mvar()
112 mcoeff = m_one; in find_mvar()
118 mcoeff.clear(); in get_multiplier()
128 if(mcoeff.isZero()) mcoeff.set(1, 1, 0); in get_multiplier()
141 if(mcoeff.isZero()) mcoeff = (*mcur)[i3]; in get_multiplier()
152 if(mcoeff[mcoeff.size() - 1].isZero()) mcoeff[mcoeff.size() - 1] = (*mcur)[i3]; in get_multiplier()
153 else mcoeff[mcoeff.size() - 1].multiply((*mcur)[i3], true); in get_multiplier()
171 if(mcoeff.isZero()) mcoeff = (*mcur)[i3]; in get_multiplier()
182 if(mcoeff[mcoeff.size() - 1].isZero()) mcoeff[mcoeff.size() - 1] = (*mcur)[i3]; in get_multiplier()
183 else mcoeff[mcoeff.size() - 1].multiply((*mcur)[i3], true); in get_multiplier()
[all …]
H A DMathStructure.h878 void lcoefficient(const MathStructure &xvar, MathStructure &mcoeff) const;
879 void tcoefficient(const MathStructure &xvar, MathStructure &mcoeff) const;
880 void coefficient(const MathStructure &xvar, const Number &pownr, MathStructure &mcoeff) const;
/dports/math/mfem/mfem-4.3/tests/unit/fem/
H A Dtest_assemblediagonalpa.cpp196 MatrixCoefficient* mcoeff = nullptr; variable
212 mcoeff = new MatrixFunctionCoefficient(dimension,
219 mcoeff = new MatrixFunctionCoefficient(dimension,
229 paform.AddDomainIntegrator(new DiffusionIntegrator(*mcoeff));
230 faform.AddDomainIntegrator(new DiffusionIntegrator(*mcoeff));
235 faform.AddDomainIntegrator(new DiffusionIntegrator(*mcoeff));
265 delete mcoeff;
367 MatrixCoefficient* mcoeff = nullptr; variable
383 mcoeff = new MatrixFunctionCoefficient(dimension,
390 mcoeff = new MatrixFunctionCoefficient(dimension,
[all …]
H A Dtest_pa_coeff.cpp164 MatrixCoefficient* mcoeff = nullptr; variable
188 mcoeff = new MatrixFunctionCoefficient(dimension,
195 mcoeff = new MatrixFunctionCoefficient(dimension,
212 paform.AddDomainIntegrator(new DiffusionIntegrator(*mcoeff));
236 assemblyform.AddDomainIntegrator(new DiffusionIntegrator(*mcoeff));
280 delete mcoeff;
313 MatrixCoefficient* mcoeff = nullptr; variable
332 mcoeff = new MatrixFunctionCoefficient(dimension,
340 mcoeff = new MatrixFunctionCoefficient(dimension,
466 paform->AddDomainIntegrator(new VectorFEMassIntegrator(*mcoeff));
[all …]
/dports/science/lammps/lammps-stable_29Sep2021/src/DRUDE/
H A Dfix_drude_transform.cpp35 Fix(lmp, narg, arg), mcoeff(nullptr) in FixDrudeTransform()
46 if (mcoeff) delete [] mcoeff; in ~FixDrudeTransform()
81 if (!mcoeff) mcoeff = new double[ntypes+1]; in setup()
98 MPI_Allreduce(mcoeff_loc, mcoeff, ntypes+1, MPI_DOUBLE, MPI_MIN, world); in setup()
155 if (mcoeff[itype] < 1.5) mass[itype] *= 1. - mcoeff[itype]; in real_to_reduced()
181 coeff = mcoeff[type[idrude]]; in real_to_reduced()
231 if (!mcoeff[type[icore]]) { // TODO: should it be > 1.5 ? in reduced_to_real()
237 mcoeff[type[icore]] = mdrude / (mcore + mdrude); in reduced_to_real()
239 coeff = mcoeff[type[idrude]]; in reduced_to_real()
258 if (mcoeff[itype] < 1.5) mass[itype] /= 1. - mcoeff[itype]; in reduced_to_real()
H A Dfix_drude_transform.h43 double *mcoeff;
/dports/science/chrono/chrono-7.0.1/src/chrono/solver/
H A DChConstraintTwoTuplesRollingN.h90 void SetRollingFrictionCoefficient(float mcoeff) { rollingfriction = mcoeff; } in SetRollingFrictionCoefficient() argument
95 void SetSpinningFrictionCoefficient(float mcoeff) { spinningfriction = mcoeff; } in SetSpinningFrictionCoefficient() argument
H A DChConstraintTwoTuplesContactN.h25 void SetFrictionCoefficient(double mcoeff) { friction = mcoeff; } in SetFrictionCoefficient() argument
/dports/misc/py-tvm/incubator-tvm-0.6.1/src/pass/
H A Dlower_warp_memory.cc117 Expr mcoeff = analyzer_->canonical_simplify(m[0]); in UpdatePattern() local
119 CHECK(arith::GetConstInt(mcoeff, &coeff) && coeff > 0) in UpdatePattern()
122 << " but get " << mcoeff; in UpdatePattern()
/dports/misc/tvm/incubator-tvm-0.6.1/src/pass/
H A Dlower_warp_memory.cc117 Expr mcoeff = analyzer_->canonical_simplify(m[0]); in UpdatePattern() local
119 CHECK(arith::GetConstInt(mcoeff, &coeff) && coeff > 0) in UpdatePattern()
122 << " but get " << mcoeff; in UpdatePattern()
/dports/astro/sextractor/sextractor-2.5.0/src/wcs/
H A Dpoly.c346 double *coeff,*mcoeff,*mcoefft, in poly_addcste() local
359 QCALLOC(mcoeff, double, ndim*maxdegree); in poly_addcste()
361 mcoefft = mcoeff; /* To avoid gcc -Wall warnings */ in poly_addcste()
369 mcoefft = mcoeff+j*maxdegree+n; in poly_addcste()
394 mcoefft = mcoeff; in poly_addcste()
415 free(mcoeff); in poly_addcste()
/dports/astro/py-astlib/astLib-0.11.7/PyWCSTools/wcssubs-3.9.5/
H A Dpoly.c346 double *coeff,*mcoeff,*mcoefft, in poly_addcste() local
359 QCALLOC(mcoeff, double, ndim*maxdegree); in poly_addcste()
361 mcoefft = mcoeff; /* To avoid gcc -Wall warnings */ in poly_addcste()
369 mcoefft = mcoeff+j*maxdegree+n; in poly_addcste()
394 mcoefft = mcoeff; in poly_addcste()
415 free(mcoeff); in poly_addcste()
/dports/misc/mxnet/incubator-mxnet-1.9.0/3rdparty/tvm/src/tir/transforms/
H A Dlower_warp_memory.cc133 PrimExpr mcoeff = analyzer_->canonical_simplify(m[0]); in UpdatePattern() local
134 const auto* mcoeff_as_int = mcoeff.as<IntImmNode>(); in UpdatePattern()
138 << mcoeff; in UpdatePattern()
/dports/math/cado-nfs/cado-nfs-f4284e2391121b2bfb97bc4880b6273c7250dc2f/tests/linalg/bwc/
H A Dbwc-ptrace.m400 Xt*MM^i*Transpose(VV[1][1]) eq mcoeff(A,i) where i is 2;
404 &+[Cr[1+i]*Ct*mcoeff(A,i):i in [0..interval-1]] eq Cdi * Transpose(VV[1][1]);
419 mcoeff:=func<M,k|
466 s:=mcoeff(Transpose(P), i) * y; function
470 s+:=mcoeff(Transpose(P), i) * y; function
500 assert mcoeff(A, k*interval) eq Matrix(m,n,[(x0[i],vx[j]):j in [1..n], i in[1..m]]); function
595 solutions[j]+:=mcoeff(mcol(F,j),k)*z; function
/dports/math/mfem/mfem-4.3/fem/
H A Dbilininteg.cpp1407 mcoeff.SetSize(vdim); in AssembleElementMatrix()
1446 MQ->Eval(mcoeff, Trans, ip); in AssembleElementMatrix()
1450 elmat.AddMatrix(norm*mcoeff(i,j), partelmat, nd*i, nd*j); in AssembleElementMatrix()
1490 mcoeff.SetSize(vdim); in AssembleElementMatrix2()
1531 MQ->Eval(mcoeff, Trans, ip); in AssembleElementMatrix2()
2517 mcoeff.SetSize(vdim); in AssembleElementMatrix()
2558 MQ->Eval(mcoeff, Trans, ip); in AssembleElementMatrix()
2563 Mult_a_AAt(w*mcoeff(i,j), dshapedxt, pelmat); in AssembleElementMatrix()
2598 mcoeff.SetSize(vdim); in AssembleElementVector()
2644 MQ->Eval(mcoeff, Tr, ip); in AssembleElementVector()
[all …]
H A Dbilininteg.hpp2220 DenseMatrix mcoeff; member in mfem::VectorMassIntegrator
2654 DenseMatrix mcoeff; member in mfem::VectorDiffusionIntegrator
/dports/math/giacxcas/giac-1.6.0/src/
H A Dcocoa.cc5903 if (mcoeff.empty()) in reducef4buchbergersplit()
5905 const modint * jt=&mcoeff.front(),*jtend=jt+mcoeff.size(),*jt_=jtend-8; in reducef4buchbergersplit()
6418 if (mcoeff.empty()) in reducef4buchbergersplit()
6420 const modint * jt=&mcoeff.front(),*jtend=jt+mcoeff.size(),*jt_=jtend-8; in reducef4buchbergersplit()
6524 if (mcoeff.empty()) in reducef4buchbergersplit()
6526 const modint * jt=&mcoeff.front(),*jtend=jt+mcoeff.size(),*jt_=jtend-8; in reducef4buchbergersplit()
6791 if (mcoeff.empty()) in reducef4buchbergersplitu()
6793 const modint * jt=&mcoeff.front(),*jtend=jt+mcoeff.size(),*jt_=jtend-8; in reducef4buchbergersplitu()
6840 vector<modint>::const_iterator jt=mcoeff.begin(),jtend=mcoeff.end(); in reducef4buchbergersplitu()
6900 if (mcoeff.empty()) in reducef4buchbergersplits()
[all …]
/dports/math/fricas/fricas-1.3.7/pre-generated/src/algebra/
H A DNBLM.lsp519 ((#1=#:G538 NIL) (|j| NIL) (|minv| (|Integer|)) (|mcoeff| (|Integer|))
525 (LETT |mcoeff| (ELT_U32 (QAREF2O |m| |i| |ci| 1 1) |cdeg|))
526 (LETT |minv| (SPADCALL |mcoeff| |p| (QREFELT $ 49)))
/dports/math/fftw3/fftw-3.3.9/genfft/
H A Dalgsimp.ml182 suminusM coeff >>= fun mcoeff ->
183 returnM (mcoeff, b)
/dports/math/fftw3-float/fftw-3.3.9/genfft/
H A Dalgsimp.ml182 suminusM coeff >>= fun mcoeff ->
183 returnM (mcoeff, b)
/dports/math/fftw3-long/fftw-3.3.9/genfft/
H A Dalgsimp.ml182 suminusM coeff >>= fun mcoeff ->
183 returnM (mcoeff, b)
/dports/math/fftw3-quad/fftw-3.3.9/genfft/
H A Dalgsimp.ml182 suminusM coeff >>= fun mcoeff ->
183 returnM (mcoeff, b)
/dports/math/fricas/fricas-1.3.7/src/algebra/
H A Dmodhpsol.spad284 mcoeff := qelt(m, i, ci)(cdeg)
285 minv := invmod(mcoeff, p)::K