Home
last modified time | relevance | path

Searched refs:right_hand_side (Results 1 – 25 of 74) sorted by relevance

123

/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/source/numerics/
H A Dmatrix_tools_once.cc76 Assert(matrix.n() == right_hand_side.size(), in apply_boundary_values()
88 Assert(local_range == right_hand_side.local_range(), in apply_boundary_values()
142 right_hand_side.set(indices, solution_values); in apply_boundary_values()
154 right_hand_side.compress(VectorOperation::insert); in apply_boundary_values()
166 Assert(matrix.n() == right_hand_side.size(), in apply_boundary_values()
204 right_hand_side.block(block), in apply_boundary_values()
253 Assert(matrix.n() == right_hand_side.size(), in apply_boundary_values()
317 right_hand_side.set(indices, solution_values); in apply_boundary_values()
330 right_hand_side.compress(VectorOperation::insert); in apply_boundary_values()
342 TrilinosBlockVector &right_hand_side, in apply_block_boundary_values() argument
[all …]
H A Dmatrix_tools.cc85 Vector<number> & right_hand_side, in apply_boundary_values() argument
88 Assert(matrix.n() == right_hand_side.size(), in apply_boundary_values()
89 ExcDimensionMismatch(matrix.n(), right_hand_side.size())); in apply_boundary_values()
154 right_hand_side(dof_number) = new_rhs; in apply_boundary_values()
160 right_hand_side(dof_number) = new_rhs; in apply_boundary_values()
225 right_hand_side(row) -= in apply_boundary_values()
246 BlockVector<number> & right_hand_side, in apply_boundary_values() argument
251 Assert(matrix.n() == right_hand_side.size(), in apply_boundary_values()
252 ExcDimensionMismatch(matrix.n(), right_hand_side.size())); in apply_boundary_values()
263 right_hand_side.get_block_indices(), in apply_boundary_values()
[all …]
H A Dmatrix_tools.inst.in29 Vector<number> & right_hand_side,
36 BlockVector<number> & right_hand_side,
46 Vector<number> & right_hand_side,
/dports/science/py-scipy/scipy-1.7.1/scipy/special/cephes/
H A Dndtr.c321 right_hand_side = 1, /* includes first term from the RHS summation */ in log_ndtr() local
335 while (fabs(last_total - right_hand_side) > DBL_EPSILON) { in log_ndtr()
337 last_total = right_hand_side; in log_ndtr()
341 right_hand_side += sign * numerator * denom_factor; in log_ndtr()
344 return log_LHS + log(right_hand_side); in log_ndtr()
/dports/math/py-chaospy/chaospy-4.3.3/chaospy/quadrature/
H A Dradau.py171 right_hand_side = numpy.zeros(len(coeffs[0])-1)
172 right_hand_side[-1] = coeffs[1][-1]
176 delta = scipy.linalg.solve_banded((1, 1), bands_j, right_hand_side)
/dports/math/py-or-tools/or-tools-9.2/ortools/glop/
H A Dbasis_representation.cc546 ScatteredColumn right_hand_side;
547 right_hand_side.values.AssignToZero(num_rows);
548 right_hand_side[ColToRowIndex(col)] = 1.0;
550 RightSolve(&right_hand_side);
554 column_norm += std::abs(right_hand_side[row]);
568 ScatteredColumn right_hand_side;
569 right_hand_side.values.AssignToZero(num_rows);
570 right_hand_side[ColToRowIndex(col)] = 1.0;
572 RightSolve(&right_hand_side);
575 row_sum[row] += std::abs(right_hand_side[row]);
H A Dlu_factorization.cc497 DenseColumn right_hand_side(num_rows, 0.0);
498 right_hand_side[ColToRowIndex(col)] = 1.0;
500 RightSolve(&right_hand_side);
504 column_norm += std::abs(right_hand_side[row]);
518 DenseColumn right_hand_side(num_rows, 0.0);
519 right_hand_side[ColToRowIndex(col)] = 1.0;
521 RightSolve(&right_hand_side);
524 row_sum[row] += std::abs(right_hand_side[row]);
/dports/math/py-sympy/sympy-1.9/sympy/physics/mechanics/
H A Dsystem.py209 def __init__(self, coord_states, right_hand_side, speeds=None, argument
238 self._dyn_implicit_rhs = right_hand_side
247 self._comb_implicit_rhs = right_hand_side
256 self._comb_explicit_rhs = right_hand_side
/dports/devel/ppl/ppl-1.2/tests/Concrete_Expression/
H A DC_Expr_inlines.hh52 const Concrete_Expression<C_Expr>* right_hand_side) in Binary_Operator() argument
56 rhs(right_hand_side) { in Binary_Operator()
79 Binary_Operator<C_Expr>::right_hand_side() const { in right_hand_side() function in Parma_Polyhedra_Library::Binary_Operator
H A DC_Expr_defs.hh70 const Concrete_Expression<C_Expr>* right_hand_side);
85 const Concrete_Expression<C_Expr>* right_hand_side() const;
/dports/biology/hyphy/hyphy-2.5.33/src/core/
H A Dvariable.cpp652 _Formula* right_hand_side = &theF; in SetFormula() local
657 right_hand_side = new _Formula ((HBLObjectRef)theP->makeDynamic(),false); in SetFormula()
669 if (&theF!=right_hand_side) { in SetFormula()
670 delete right_hand_side; in SetFormula()
698 varFormula->Duplicate (right_hand_side); in SetFormula()
732 if (&theF!=right_hand_side) { in SetFormula()
733 delete right_hand_side; in SetFormula()
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/include/deal.II/numerics/
H A Dmatrix_tools.h836 Vector<number> & right_hand_side,
850 BlockVector<number> & right_hand_side,
894 PETScWrappers::VectorBase & right_hand_side,
905 PETScWrappers::MPI::BlockVector & right_hand_side,
949 TrilinosWrappers::MPI::Vector & right_hand_side,
961 TrilinosWrappers::MPI::BlockVector & right_hand_side,
/dports/math/octave/octave-6.4.0/libinterp/parse-tree/
H A Dpt-check.cc126 tree_expression *rhs = expr.right_hand_side (); in visit_multi_assignment()
143 tree_expression *rhs = expr.right_hand_side (); in visit_simple_assignment()
H A Dpt-assign.h79 tree_expression * right_hand_side (void) { return m_rhs; } in right_hand_side() function
150 tree_expression * right_hand_side (void) { return m_rhs; } in right_hand_side() function
/dports/science/elmerfem/elmerfem-release-9.0/ElmerWorkflows/FreeCADBatchFEMTools/
H A Dmeshutils.py60 … left_hand_side, right_hand_side = line.split('=') # Physical Volume("SolidName") = {2, 3};
62 … geom_id_dict[volume_or_surface_name] = parse_geo_id_list_string_to_list(right_hand_side)
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/include/deal.II/lac/
H A Dconstrained_linear_operator.h295 const Range & right_hand_side) in constrained_right_hand_side() argument
301 return_comp.apply_add = [&constraints, &linop, &right_hand_side](Range &v) { in constrained_right_hand_side()
310 v += Ct * (right_hand_side - linop * *k); in constrained_right_hand_side()
/dports/math/py-or-tools/or-tools-9.2/ortools/linear_solver/
H A Dglpk_interface.cc820 std::unique_ptr<double[]> right_hand_side(new double[num_rows + 1]); in ComputeInverseScaledBasisL1Norm() local
836 right_hand_side[row] = 0.0; in ComputeInverseScaledBasisL1Norm()
838 right_hand_side[k] = 1.0; in ComputeInverseScaledBasisL1Norm()
841 right_hand_side[row] /= row_scaling_factor[row]; in ComputeInverseScaledBasisL1Norm()
843 glp_ftran(lp_, right_hand_side.get()); in ComputeInverseScaledBasisL1Norm()
851 right_hand_side[row] *= row_scaling_factor[k]; in ComputeInverseScaledBasisL1Norm()
854 right_hand_side[row] /= column_scaling_factor[k - num_rows]; in ComputeInverseScaledBasisL1Norm()
860 column_norm += fabs(right_hand_side[row]); in ComputeInverseScaledBasisL1Norm()
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/examples/step-50/
H A Dstep-50.cc441 VectorType right_hand_side; member in LaplaceProblem
497 right_hand_side.reinit(locally_owned_dofs, mpi_communicator); in setup_system()
792 right_hand_side); in assemble_system()
796 right_hand_side.compress(VectorOperation::add); in assemble_system()
972 ChangeVectorTypes::copy(right_hand_side, right_hand_side_copy); in assemble_rhs()
987 SolverControl solver_control(1000, 1.e-10 * right_hand_side.l2_norm()); in solve()
1050 ChangeVectorTypes::copy(right_hand_side_copy, right_hand_side); in solve()
1132 preconditioner.vmult(solution, right_hand_side); in solve()
1143 right_hand_side, in solve()
1179 preconditioner.vmult(solution, right_hand_side); in solve()
[all …]
/dports/devel/ppl/ppl-1.2/src/
H A Dlinearize.hh129 if (!linearize(*(bop_expr.right_hand_side()), oracle, lf_store, in add_linearize()
242 if (!linearize(*(bop_expr.right_hand_side()), oracle, lf_store, in sub_linearize()
400 if (!linearize(*(bop_expr.right_hand_side()), oracle, lf_store, in mul_linearize()
569 if (!linearize(*(bop_expr.right_hand_side()), oracle, lf_store, in div_linearize()
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/examples/step-12b/
H A Dstep-12b.cc185 Vector<double> right_hand_side; member in Step12::AdvectionProblem
251 right_hand_side.reinit(dof_handler.n_dofs()); in setup_system()
305 assembler.initialize(system_matrix, right_hand_side); in assemble_system()
521 solver.solve(system_matrix, solution, right_hand_side, preconditioner); in solve()
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/examples/step-62/
H A Dstep-62.cc206 const RightHandSide<dim> right_hand_side; member in step62::Parameters
240 std::vector<std::complex<double>> right_hand_side; member in step62::QuadratureCache
673 , right_hand_side(data) in Parameters()
689 , right_hand_side(dofs_per_cell) in QuadratureCache()
834 parameters.right_hand_side.vector_value_list( in assemble_system()
955 quadrature_data.right_hand_side[i] = in assemble_system()
974 cell_rhs(i) += quadrature_data.right_hand_side[i]; in assemble_system()
1144 parameters.right_hand_side.value(cell->center(), dim_idx); in store_frequency_step_data()
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/examples/step-12/
H A Dstep-12.cc247 Vector<double> right_hand_side; member in Step12::AdvectionProblem
283 right_hand_side.reinit(dof_handler.n_dofs()); in setup_system()
428 right_hand_side); in assemble_system()
483 solver.solve(system_matrix, solution, right_hand_side, preconditioner); in solve()
/dports/devel/ppl/ppl-1.2/interfaces/Java/parma_polyhedra_library/
H A DLinear_Expression_Difference.java53 public Linear_Expression right_hand_side() { in right_hand_side() method in Linear_Expression_Difference
H A DLinear_Expression_Sum.java49 public Linear_Expression right_hand_side() { in right_hand_side() method in Linear_Expression_Sum
/dports/math/geogram/geogram-1.7.7/src/lib/geogram/NL/
H A Dnl_api.c598 nlCurrentContext->right_hand_side = NL_NEW_ARRAY( in nlInitializeMSystem()
758 nlCurrentContext->right_hand_side[k] *= s; in nlScaleRow()
813 S = -nlCurrentContext->right_hand_side[k]; in nlEndRow()
830 b[k*n+current_row] = nlCurrentContext->right_hand_side[k]; in nlEndRow()
840 nlCurrentContext->right_hand_side[k] = 0.0; in nlEndRow()
923 nlCurrentContext->right_hand_side[0] = value; in nlRightHandSide()
928 nlCurrentContext->right_hand_side[k] = value; in nlMultiRightHandSide()

123