Searched defs:solve (Results 26 - 50 of 65) sorted by relevance

123

/external/javaparser/javaparser-symbol-solver-core/src/main/java/com/github/javaparser/symbolsolver/
H A DSourceFileInfoExtractor.java114 private void solve(Node node) { method in class:SourceFileInfoExtractor
151 return toString(JavaParserFacade.get(typeSolver).solve(node));
181 public void solve(File file) throws IOException, ParseException { method in class:SourceFileInfoExtractor
184 solve(f);
193 nodes.forEach(n -> solve(n));
/external/tensorflow/tensorflow/python/ops/linalg/
H A Dlinalg_impl.py50 solve = linalg_ops.matrix_solve variable
H A Dlinear_operator.py85 `rhs` is a batch matrix with compatible shape for `solve` if
159 `solve` will have to be this type.
725 "Using (possibly slow) default implementation of solve."
733 def solve(self, rhs, adjoint=False, adjoint_arg=False, name="solve"): member in class:LinearOperator
749 X = operator.solve(RHS)
762 adjoint: Python `bool`. If `True`, solve the system involving the adjoint
764 adjoint_arg: Python `bool`. If `True`, solve `A X = rhs^H` where `rhs^H`
776 "Exact solve not implemented for an operator that is expected to "
780 "Exact solve no
[all...]
/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/solvers/
H A DUnivariateRealSolverImpl.java54 /** The function to solve.
55 * @deprecated as of 2.0 the function to solve is passed as an argument
56 * to the {@link #solve(UnivariateRealFunction, double, double)} or
57 * {@link UnivariateRealSolverImpl#solve(UnivariateRealFunction, double, double, double)}
65 * @param f the function to solve.
70 * @deprecated as of 2.0 the function to solve is passed as an argument
71 * to the {@link #solve(UnivariateRealFunction, double, double)} or
72 * {@link UnivariateRealSolverImpl#solve(UnivariateRealFunction, double, double, double)}
145 * @param function the function to solve.
157 public double solve(in method in class:UnivariateRealSolverImpl
181 public double solve(int maxEval, UnivariateRealFunction function, double min, double max, double startValue) method in class:UnivariateRealSolverImpl
[all...]
/external/apache-commons-math/src/main/java/org/apache/commons/math/linear/
H A DBigMatrix.java316 BigDecimal[] solve(BigDecimal[] b) throws IllegalArgumentException, InvalidMatrixException; method in interface:BigMatrix
324 * to solve
329 BigMatrix solve(BigMatrix b) throws IllegalArgumentException, InvalidMatrixException; method in interface:BigMatrix
H A DAbstractRealMatrix.java941 public double[] solve(final double[] b) method in class:AbstractRealMatrix
946 return lu.solve(b);
951 public RealMatrix solve(final RealMatrix b) method in class:AbstractRealMatrix
956 return lu.solve(b);
H A DBigMatrixImpl.java32 * <li>solve</li>
933 return solve(MatrixUtils.createBigIdentityMatrix(getRowDimension()));
1092 * to solve
1097 public BigDecimal[] solve(BigDecimal[] b) throws IllegalArgumentException, InvalidMatrixException { method in class:BigMatrixImpl
1105 final BigDecimal[][] solution = ((BigMatrixImpl) (solve(bMatrix))).getDataRef();
1119 * to solve
1124 public BigDecimal[] solve(double[] b) throws IllegalArgumentException, InvalidMatrixException { method in class:BigMatrixImpl
1129 return solve(bd);
1138 * to solve
1143 public BigMatrix solve(BigMatri method in class:BigMatrixImpl
[all...]
H A DRealMatrix.java851 * @deprecated as of release 2.0, replaced by {@link DecompositionSolver#solve(double[])}
854 double[] solve(double[] b) throws IllegalArgumentException, InvalidMatrixException; method in interface:RealMatrix
862 * to solve
866 * @deprecated as of release 2.0, replaced by {@link DecompositionSolver#solve(RealMatrix)}
869 RealMatrix solve(RealMatrix b) throws IllegalArgumentException, InvalidMatrixException; method in interface:RealMatrix
/external/eigen/Eigen/src/Core/
H A DSolveTriangular.h188 TriangularViewImpl<Derived,Mode,Dense>::solve(const MatrixBase<Other>& other) const function in class:Eigen::TriangularViewImpl
/external/eigen/Eigen/src/QR/
H A DHouseholderQR.h127 * \param b the right-hand-side of the equation to solve.
140 solve(const MatrixBase<Rhs>& b) const function in class:Eigen::HouseholderQR
H A DColPivHouseholderQR.h162 * \param b the right-hand-side of the equation to solve.
175 solve(const MatrixBase<Rhs>& b) const function in class:Eigen::ColPivHouseholderQR
623 dst = src.nestedExpression().solve(MatrixType::Identity(src.rows(), src.cols()));
H A DCompleteOrthogonalDecomposition.h141 * \param b the right-hand sides of the problem to solve.
147 inline const Solve<CompleteOrthogonalDecomposition, Rhs> solve( function in class:Eigen::CompleteOrthogonalDecomposition
273 * \warning: Do not compute \c this->pseudoInverse()*rhs to solve a linear systems.
274 * It is more efficient and numerically stable to call \c this->solve(rhs).
513 .solve(c.topRows(rank));
537 dst = src.nestedExpression().solve(MatrixType::Identity(src.rows(), src.rows()));
H A DFullPivHouseholderQR.h162 * \param b the right-hand-side of the equation to solve.
176 solve(const MatrixBase<Rhs>& b) const function in class:Eigen::FullPivHouseholderQR
585 dst = src.nestedExpression().solve(MatrixType::Identity(src.rows(), src.cols()));
/external/eigen/Eigen/src/SVD/
H A DSVDBase.h141 /** Allows to prescribe a threshold to be used by certain methods, such as rank() and solve(),
197 * \param b the right-hand-side of the equation to solve.
206 solve(const MatrixBase<Rhs>& b) const function in class:Eigen::SVDBase
209 eigen_assert(computeU() && computeV() && "SVD::solve() requires both unitaries U and V to be computed (thin unitaries suffice).");
/external/eigen/unsupported/Eigen/src/Skyline/
H A DSkylineInplaceLU.h99 bool solve(const MatrixBase<BDerived> &b, MatrixBase<XDerived>* x,
307 bool SkylineInplaceLU<MatrixType>::solve(const MatrixBase<BDerived> &b, MatrixBase<XDerived>* x, const int transposed) const { function in class:Eigen::SkylineInplaceLU
/external/javaparser/javaparser-symbol-solver-core/src/main/java/com/github/javaparser/symbolsolver/javaparsermodel/
H A DJavaParserFacade.java50 * Class to be used by final users to solve symbols for JavaParser ASTs.
115 public SymbolReference<? extends ResolvedValueDeclaration> solve(NameExpr nameExpr) { method in class:JavaParserFacade
119 public SymbolReference<? extends ResolvedValueDeclaration> solve(SimpleName nameExpr) { method in class:JavaParserFacade
123 public SymbolReference<? extends ResolvedValueDeclaration> solve(Expression expr) { method in class:JavaParserFacade
124 return expr.toNameExpr().map(this::solve).orElseThrow(() -> new IllegalArgumentException(expr.getClass().getCanonicalName()));
127 public SymbolReference<ResolvedMethodDeclaration> solve(MethodCallExpr methodCallExpr) { method in class:JavaParserFacade
128 return solve(methodCallExpr, true);
131 public SymbolReference<ResolvedConstructorDeclaration> solve(ObjectCreationExpr objectCreationExpr) { method in class:JavaParserFacade
132 return solve(objectCreationExpr, true);
135 public SymbolReference<ResolvedConstructorDeclaration> solve(ExplicitConstructorInvocationStm method in class:JavaParserFacade
139 public SymbolReference<ResolvedConstructorDeclaration> solve(ExplicitConstructorInvocationStmt explicitConstructorInvocationStmt, boolean solveLambdas) { method in class:JavaParserFacade
172 public SymbolReference<ResolvedTypeDeclaration> solve(ThisExpr node) { method in class:JavaParserFacade
197 public SymbolReference<ResolvedConstructorDeclaration> solve(ObjectCreationExpr objectCreationExpr, boolean solveLambdas) { method in class:JavaParserFacade
239 public SymbolReference<ResolvedMethodDeclaration> solve(MethodCallExpr methodCallExpr, boolean solveLambdas) { method in class:JavaParserFacade
252 public SymbolReference<ResolvedAnnotationDeclaration> solve(AnnotationExpr annotationExpr) { method in class:JavaParserFacade
263 public SymbolReference<ResolvedFieldDeclaration> solve(FieldAccessExpr fieldAccessExpr) { method in class:JavaParserFacade
[all...]
/external/python/cpython3/Lib/test/
H A Dtest_generators.py1394 def solve(self): member in class:Queens
1419 # solve() will set up succs[i] to be a list of square #i's
1581 def solve(self): member in class:Knights
1649 >>> for row2col in q.solve():
1700 >>> for x in k.solve():
/external/trappy/tests/trappy/stats/
H A Dgrammar.py289 parser.solve("trappy.thermal.Thermal:temp * 2")
300 parser.solve("THERMAL:temp * 2")
309 parser.solve("thermal:temp * 2")
326 parser.solve("CUSTOM:col * 2")
352 def solve(self, expr): member in class:Parser
369 parser.solve("trappy.thermal.Thermal:temp * 2")
379 parser.solve("numpy.mean(trappy.thermal.Thermal:temp)")
389 parser.solve("trappy.thermal.Thermal:temp > 65000")
/external/trappy/trappy/stats/
H A Dgrammar.py289 parser.solve("trappy.thermal.Thermal:temp * 2")
300 parser.solve("THERMAL:temp * 2")
309 parser.solve("thermal:temp * 2")
326 parser.solve("CUSTOM:col * 2")
352 def solve(self, expr): member in class:Parser
369 parser.solve("trappy.thermal.Thermal:temp * 2")
379 parser.solve("numpy.mean(trappy.thermal.Thermal:temp)")
389 parser.solve("trappy.thermal.Thermal:temp > 65000")
/external/eigen/Eigen/src/Cholesky/
H A DLLT.h32 * While the Cholesky decomposition is particularly useful to solve selfadjoint problems like D^*D x = b,
140 solve(const MatrixBase<Rhs>& b) const function in class:Eigen::LLT
144 && "LLT::solve(): invalid number of rows of the right hand side matrix b");
191 * \code x = decomposition.adjoint().solve(b) \endcode
480 /** \internal use x = llt_object.solve(x);
482 * This is the \em in-place version of solve().
488 * \sa LLT::solve(), MatrixBase::llt()
H A DLDLT.h185 * This function also supports in-place solves using the syntax <tt>x = decompositionObject.solve(x)</tt> .
200 solve(const MatrixBase<Rhs>& b) const function in class:Eigen::LDLT
204 && "LDLT::solve(): invalid number of rows of the right hand side matrix b");
241 * \code x = decomposition.adjoint().solve(b) \endcode
595 /** \internal use x = ldlt_object.solve(x);
597 * This is the \em in-place version of solve().
606 * \sa LDLT::solve(), MatrixBase::ldlt()
615 bAndX = this->solve(bAndX);
/external/eigen/Eigen/src/LU/
H A DPartialPivLU.h158 * \param b the right-hand-side of the equation to solve. Can be a vector or a matrix,
170 * \sa TriangularView::solve(), inverse(), computeInverse()
175 solve(const MatrixBase<Rhs>& b) const function in class:Eigen::PartialPivLU
260 dst = m_lu.template triangularView<Upper>().adjoint().solve(rhs);
265 dst = m_lu.template triangularView<Upper>().transpose().solve(rhs);
574 dst = src.nestedExpression().solve(MatrixType::Identity(src.rows(), src.cols()));
H A DFullPivLU.h224 * \param b the right-hand-side of the equation to solve. Can be a vector or a matrix,
238 * \sa TriangularView::solve(), kernel(), inverse()
243 solve(const MatrixBase<Rhs>& b) const function in class:Eigen::FullPivLU
740 /***** Implementation of solve() *****************************************************/
869 dst = src.nestedExpression().solve(MatrixType::Identity(src.rows(), src.cols()));
/external/eigen/unsupported/Eigen/src/NonLinearOptimization/
H A DHybridNonLinearSolver.h78 HybridNonLinearSolverSpace::Status solve(FVectorType &x);
138 return solve(x);
344 HybridNonLinearSolver<FunctorType,Scalar>::solve(FVectorType &x) function in class:Eigen::HybridNonLinearSolver
/external/eigen/Eigen/src/SparseQR/
H A DSparseQR.h195 eigen_assert(this->rows() == B.rows() && "SparseQR::solve() : invalid number of rows in the right hand side matrix");
206 y.topRows(rank) = this->matrixR().topLeftCorner(rank, rank).template triangularView<Upper>().solve(b.topRows(rank));
233 inline const Solve<SparseQR, Rhs> solve(const MatrixBase<Rhs>& B) const function in class:Eigen::SparseQR
236 eigen_assert(this->rows() == B.rows() && "SparseQR::solve() : invalid number of rows in the right hand side matrix");
240 inline const Solve<SparseQR, Rhs> solve(const SparseMatrixBase<Rhs>& B) const function in class:Eigen::SparseQR
243 eigen_assert(this->rows() == B.rows() && "SparseQR::solve() : invalid number of rows in the right hand side matrix");

Completed in 1229 milliseconds

123