112 messages from Google Code

9 views
Skip to first unread message

sy...@googlecode.com

unread,
Apr 6, 2014, 3:00:38 AM4/6/14
to sympy-...@googlegroups.com
Your project notifications generated too many emails to send
individually. Here are the subject lines of the emails you would have
received:

Re: Issue 1319 in sympy: constants left out in matching d/dx(g(x)*dy/dx)
Re: Issue 1334 in sympy: point= argument of .series has no effect
Re: Issue 1323 in sympy: integrate(1/sqrt(16 + 4*x**2), x) fails
Re: Issue 1336 in sympy: Arbitrary constant type
Re: Issue 1326 in sympy: 10**1000000 takes Python forever to construct
Re: Issue 1322 in sympy: f(x**2).diff(x).diff(x) should get simplified more
Re: Issue 1321 in sympy: trigonometric functions of floating-point numbers
should return floating-point numbers
Re: Issue 1325 in sympy: solve(2**x-5*x, x) gives assertionerror
Re: Issue 1320 in sympy: simplify does not simplify commutted diffs
Re: Issue 1316 in sympy: -Qnew tests fail
Re: Issue 1327 in sympy: Derivative doesn't play well with noncommutative
symbols
Re: Issue 1333 in sympy: Integral(x,x).series(x) raises TypeError
Re: Issue 1330 in sympy: Fix output of standard form in the LaTeX printer
class
Re: Issue 1331 in sympy: secondquand tests fixed
Re: Issue 1324 in sympy: Latex printing of matrices is not working
Re: Issue 1332 in sympy: problem with eigenvalue example
Re: Issue 1317 in sympy: Wild/match does not discard x correctly
Re: Issue 1335 in sympy: WildFunction() broken
Re: Issue 1328 in sympy: improvements to our bin/test framework
Re: Issue 1329 in sympy: ccode: fractions use integer division when not
intended
Re: Issue 1318 in sympy: Interval arithmetic support
Re: Issue 1342 in sympy: Calulating a series expansion hangs
Re: Issue 1348 in sympy: python printer incorretly treats 1/2
Re: Issue 1343 in sympy: Polynomial GCD examples seem to be broken
Re: Issue 1355 in sympy: factor(expand((sin(x)+sin(y))*(cos(x)+cos(y))))
fails
Re: Issue 1340 in sympy: Cannot use Differential Equations
Re: Issue 1354 in sympy: Segment.__contains__ returns invalid result for
vertical segments
Re: Issue 1341 in sympy: Sympy has pexpect dependancy
Re: Issue 1345 in sympy: trigsimp(sin(x)/cos(x)) fixed
Re: Issue 1349 in sympy: 'int' object has no attribute 'is_Add'
Re: Issue 1353 in sympy: solve() doesn't work with Sage types as input
Re: Issue 1338 in sympy: assert poly is not None in solve
Re: Issue 1344 in sympy: recusive trigsimp implemented
Re: Issue 1339 in sympy: rendering partial derivatives instead of d?
Re: Issue 1352 in sympy: Make lambdify work with Integral:
Re: Issue 1356 in sympy: evalf(), sstr(), pretty(), latex(), ... should
raise an exception if passed wrong kwarg
Re: Issue 1337 in sympy: Refactor find() and replace()
Re: Issue 1346 in sympy: hack from a fraction() removed
Re: Issue 1350 in sympy: Is WildFunction broken?
Re: Issue 1351 in sympy: make Integral.subs() work
Re: Issue 1347 in sympy: creating lambda evaluator failed
Re: Issue 1371 in sympy: use scipy for integrals evaluation
Re: Issue 1361 in sympy: Switch to Maxima-like simplification functions
Re: Issue 1364 in sympy: simple equations involving log()
Re: Issue 1358 in sympy: (e*f*e*f).subs(e*f,f*e+h) fails if e*f is not
commutative
Re: Issue 1357 in sympy: enhance Integral.evalf() by an option to use scipy
for evaluation
Re: Issue 1368 in sympy: solve((a**2 + 1) * (sin(a*x) + cos(a*x)), x) fails
Re: Issue 1370 in sympy: Incorrect result from integral
Re: Issue 1369 in sympy: sympy doesn't work with ipython+autocall 2
Re: Issue 1373 in sympy: Order of exponential is not constant
Re: Issue 1365 in sympy: improve solve
Re: Issue 1363 in sympy: solve(-3*a/x**(S(1)/2), x) fails
Re: Issue 1360 in sympy: "integrate" doesn't allow the use of functions as
the variable of integration.
Re: Issue 1366 in sympy: limit(10*exp(-a*x)*sin(a*x), x, -oo) fails
Re: Issue 1359 in sympy: Integer square root in integerpolys.py
Re: Issue 1362 in sympy: Expand support for printing derivatives
Re: Issue 1367 in sympy: solve(exp(x)/(8*(a + x)**2), x) fails
Re: Issue 1372 in sympy: make lambdify to use scipy for integration
optionally
Re: Issue 1374 in sympy: simplify(x**2-x**2.0) does not yield 0.
Re: Issue 1381 in sympy: error with mpmath documentation
Re: Issue 1380 in sympy: solve(2*x/(x+2)-1,x) gives error
Re: Issue 1382 in sympy: Documentation Error in "Finding all roots of a
polynomial"
Re: Issue 1387 in sympy: solve(x+sqrt(x)-2,x) returns wrong solution
Re: Issue 1384 in sympy: clean-up Symbol's assumptions
Re: Issue 1375 in sympy: Documentation problem with python-sphinx
Re: Issue 1379 in sympy: documentation tests fail when run in interactive
mode
Re: Issue 1388 in sympy: integrate(exp(-x)*x**n, x) fails
Re: Issue 1385 in sympy: Integral.midpoint() implemented
Re: Issue 1377 in sympy: MathML output for Integral and Differentiate
invalid
Re: Issue 1386 in sympy: data/IPython/ipythonrc-sympy doesn't seem to work:
Re: Issue 1383 in sympy: ERROR in to Chebyshev approximation documentation
Re: Issue 1378 in sympy: Fixed spelling in GAsympy.txt
Re: Issue 1376 in sympy: sympy.sum overrides built-in sum with a different
call syntax
Re: Issue 1394 in sympy: integrate(x*sqrt(1+2*x), x) can't do it yet
Re: Issue 1393 in sympy: Implement heuristics for integrating common
algebraic functions
Re: Issue 1395 in sympy: trigsimp doesn't simplify an expression that == 1
Re: Issue 1403 in sympy: more tests for lambdify
Re: Issue 1405 in sympy: solve solves 10-2**x for x but not 2**x-10
Re: Issue 1404 in sympy: limit((sqrt(1+exp(x+dx))-sqrt(1+exp(x)))/dx,dx,0)
fails
Re: Issue 1392 in sympy: integrate(x*sqrt(x**2+2*x+4), x) can't do it yet
Re: Issue 1406 in sympy: solve solves b*a**x-y, y-b*a**x, or y-a**x for x
but not a**x-y
Re: Issue 1391 in sympy: integrate(cos(x)*f(x),(x,0,y)) gives wrong result
Re: Issue 1402 in sympy: limit((exp(2*x)-1-log(1+2*x))/x**2, x, 0) is wrong
Re: Issue 1400 in sympy: make cse optionally not to generate subexpressions
that are only used once
Re: Issue 1398 in sympy: solve(1/(5+x)**(S(1)/5)-9, x) fails
Re: Issue 1407 in sympy: solve doesn't recognize that tsolve can solve
y-a*x**b for x
Re: Issue 1389 in sympy: pretty should have an option to disable line
wrapping
Re: Issue 1390 in sympy: setup.py --record: manpage of isympy.1 is not
listed correctly
Re: Issue 1397 in sympy: solve fails for a sum of two fractions
Re: Issue 1401 in sympy: 'simplify' not idempotent?
Re: Issue 1396 in sympy: separate pyglet from sympy, ship all in one
package: SPD
Re: Issue 1399 in sympy: make cse recognize negative of a subexpression
Re: Issue 1423 in sympy: integrating DiracDelta fails sometimes
Re: Issue 1415 in sympy: integrate(sin(2*x)/ sin(x)) fails
Re: Issue 1412 in sympy: integrate(cos(x)**2 / (1-sin(x))) gives too
complicated answer
Re: Issue 1413 in sympy: integrate(cos(x)**2 / (1-sin(x))) gives too
complicated answer
Re: Issue 1416 in sympy: integrate((x**3 - x)/ (x - 1), x) gives traceback
Re: Issue 1421 in sympy: QRdecomposition fails for some matrices
Re: Issue 1414 in sympy: Some tests fail on headless machine
Re: Issue 1418 in sympy: integrate((x**Rational(1,2) -
x**3)/x**Rational(1,3), x) gives traceback
Re: Issue 1419 in sympy: integrate(x/(x**2-9), x) gives wrong answers
Re: Issue 1417 in sympy: integrate(2**x - 2*x, x) gives traceback
Re: Issue 1410 in sympy: solve doesn't factor out a common exponential from
system of equations
Re: Issue 1420 in sympy: subs() seems to fail against D(x(t), t)
Re: Issue 1426 in sympy: failing integral
Re: Issue 1427 in sympy: subs for sqrt(a/b) is wrong
Re: Issue 1411 in sympy: Make fancy latex printing work within the Sage
notebook
Re: Issue 1425 in sympy: solve (through tsolve) returns AssertionError
instead of NotImplementedError
Re: Issue 1408 in sympy: solve doesn't recognize that tsolve can solve
y-b/(1+a*x) for x
Re: Issue 1409 in sympy: two simple equations slipping past solve and tsolve
Re: Issue 1422 in sympy: spherical bessel functions
Re: Issue 1424 in sympy: integrate(DiracDelta(x).diff(x) * x, (x, -1, 1))
can't do it yet

sy...@googlecode.com

unread,
Apr 6, 2014, 3:06:39 AM4/6/14
to sympy-...@googlegroups.com
Your project notifications generated too many emails to send
individually. Here are the subject lines of the emails you would have
received:

Re: Issue 1994 in sympy: repr(Matrix) does not give re-executable string
Re: Issue 1988 in sympy: Fix printing of matrices with 0 rows or columns
Re: Issue 1993 in sympy: make sign simplification part of canonicalizing
process
Re: Issue 1986 in sympy: cse eats derivatives
Re: Issue 1989 in sympy: Remove depricated Matrix functions
Re: Issue 1990 in sympy: Matrix inconsistencies
Re: Issue 1980 in sympy: has, has_any_symbols, has_all_symbols unified
Re: Issue 1985 in sympy: as_real_imag() gives wrong answer when expanding
quotient
Re: Issue 1984 in sympy: canonicalize bases of powers with respect to sign
Re: Issue 1995 in sympy: Pretty Printing the comma with matrices
Re: Issue 1996 in sympy: Incorrect exception in dsolve()
Re: Issue 1991 in sympy: Don't use assert in the library code when an
exception would be better
Re: Issue 1987 in sympy: Integral(f(x), (x, g(x), h(x))).diff(x)
incorrectly returns 0
Re: Issue 1981 in sympy: lambert simplifications
Re: Issue 1983 in sympy: unify mul and pow handling of Add**e
Re: Issue 1999 in sympy: Integral(..., (x, foo, foo)).doit() should
autosimplify to 0 (without calculating the integral)
Re: Issue 1997 in sympy: Bug in dsolve() undetermined coefficients solver
Re: Issue 1982 in sympy: use is None instead of == None
Re: Issue 2000 in sympy: Inconsistencies with limit()
Re: Issue 1979 in sympy: atoms can use sets internally
Re: Issue 2011 in sympy: less self-confident simplify
Re: Issue 2010 in sympy: Integration with the full Risch Algorithm
Re: Issue 2002 in sympy: has() doesn't like sqrt
Re: Issue 2012 in sympy: rewrite should also be a function
Re: Issue 2009 in sympy: solve((x-y,y),x) should return {x:0} instead of
{x:y}
Re: Issue 2005 in sympy: (x**(2*y)).subs(exp(3*y*log(x)), z) gives z**(3/2)
instead of z**(2/3)
Re: Issue 2006 in sympy: Make all expressions recursively callable
Re: Issue 2001 in sympy: log(1, 1) RuntimeError: maximum recursion depth
exceeded
Re: Issue 2008 in sympy: Inconsistencies for Pow**n and exp***n
Re: Issue 2004 in sympy: more autosimplification of exp
Re: Issue 1998 in sympy: Can't use @deprecated, @wraps in the core
Re: Issue 2007 in sympy: (exp(exp(x))).atoms(exp)
Re: Issue 1992 in sympy: dummy variables of integration
Re: Issue 2003 in sympy: Use factorint() with limit argument in
sympy/core/numbers.py
Re: Issue 2023 in sympy: Plot()
Re: Issue 2015 in sympy: Hangs attempting to solve a system of linear
equations
Re: Issue 2021 in sympy: cross product always returns (1,3)-Matrix
Re: Issue 2026 in sympy: Exact, algebraic, and integer_power substitution
Re: Issue 2016 in sympy: Merge the known_fact_* data structures into a
single class.
Re: Issue 2017 in sympy: Add a writable directory for SymPy to place code
generated at install time or run time.
Re: Issue 2018 in sympy: terms vs factors
Re: Issue 2024 in sympy: Implement 'with' statement for assumptions.
Re: Issue 2022 in sympy: inconsistent behaviour of subs when using
non-commutative symbols
Re: Issue 2013 in sympy: RuntimeError with homogeneous_order(y - log(x), x,
y)
Re: Issue 2025 in sympy: should separate and separatevars work harder?
Re: Issue 2014 in sympy: use ordered_iter or iterable instead of checking
for literal container
Re: Issue 2029 in sympy: Poly simplification functions need a deep option
Re: Issue 2027 in sympy: Invalid combination of bases
Re: Issue 2028 in sympy: invalid combination of bases
Re: Issue 2020 in sympy: Symbols & Matrices
Re: Issue 2031 in sympy: Add 'auto' flag to div(), quo() and rem()
Re: Issue 2030 in sympy: Can't use 'boolean' operators with Relational
classes
Re: Issue 2019 in sympy: Add new (assumptions) fact about algebraic
elements.
Re: Issue 2050 in sympy: factoring of powers with Rational bases and hidden
positive bases
Re: Issue 2043 in sympy: log should not expand(1/x) (was "expand log can be
more complete" and "logcombine can be less strict")
Re: Issue 2040 in sympy: Better way to make a rational function out of an
expression
Re: Issue 2039 in sympy: Mul.eval_subs problems
Re: Issue 2038 in sympy: powsimp breaks power rules
Re: Issue 2047 in sympy: subs_atoms should omit more variables when doing
subs in Integral
Re: Issue 2046 in sympy: return self if expr is None else expr -- are we
ditching 2.4?
Re: Issue 2036 in sympy: How to get GCD and LCM out of three and more
Values?
Re: Issue 2032 in sympy: Ability to work with K[x, 1/x] in Polys
Re: Issue 2045 in sympy: djtheta test fail
Re: Issue 2048 in sympy: Problems with definite integrals with Function
limits and RootSum
Re: Issue 2041 in sympy: Doctest failures in Python 2.6.6
Re: Issue 2042 in sympy: Frac() object for rational function arithmetics
Re: Issue 2034 in sympy: live.sympy doesn't allow reassignment of list
subitem
Re: Issue 2033 in sympy: solve should be able to handle rational function
systems
Re: Issue 2035 in sympy: doctest puzzle
Re: Issue 2044 in sympy: log(exp(x)) != x unless x is real
Re: Issue 2049 in sympy: Derivative(f(x), x).subs(f(x), y) gives 0 instead
of Derivative(y, x)
Re: Issue 2037 in sympy: assert a == a is (almost) never a test of anything
Re: Issue 2057 in sympy: Units do not work together with evalf?
Re: Issue 2067 in sympy: (x+I*x)/(1+I).as_real_imag() doesn't give re(x),
im(x)
Re: Issue 2059 in sympy: Indexed should not wrap indices in Idx
Re: Issue 2068 in sympy: integrate(Integral(f(x), x), x) fails
Re: Issue 2071 in sympy: Wrong limit result with expressions containing
sin/cos
Re: Issue 2055 in sympy: dsolve() problem
Re: Issue 2051 in sympy: [PATCH] latex: \operatorname{\mathcal{}} is not
valid itex
Re: Issue 2069 in sympy: (-x).match(a*f(x)**b) fails to give a, b = -x, 0
(was "classify_ode() doesn't catch homogeneous_coeff when y is used")
Re: Issue 2058 in sympy: atoms doesn't work correctly with Indexed
Re: Issue 2053 in sympy: 2053 geometry upgrade
Re: Issue 2054 in sympy: does factor need to use cancel?
Re: Issue 2061 in sympy: sqrt(-1.0*x) gives infinite recursion
Re: Issue 2070 in sympy: All elements of .args should be Basic
Re: Issue 2063 in sympy: Add complete elliptic integrals
Re: Issue 2064 in sympy: terms_gcd(sqrt(4 + 4*x)) doesn't give 2*sqrt(1 + x)
Re: Issue 2052 in sympy: is_zero should default to None, not False
Re: Issue 2065 in sympy: Wrong result with expressions like limit(x**0.5,
x, oo)
Re: Issue 2056 in sympy: MathML output not implemented for Relational
operators
Re: Issue 2066 in sympy: integration of
c**2*exp(c/x)/(x**3*(1+exp(c/x)**2)) fails
Re: Issue 2060 in sympy: Infinite recursion on subs
Re: Issue 2062 in sympy: bullet proofing doit
Re: Issue 2073 in sympy: limit() throws TypeError: an integer is required
Re: Issue 2090 in sympy: coeff get's "maximum recursion depth exceeded"
Re: Issue 2075 in sympy: solve fails for eq1=1 + 2*y/b - (e + x)**2/a;
eq3=1 + 2*y/d - (x - e)**2/c
Re: Issue 2086 in sympy: SympifyError should be more explicit
Re: Issue 2083 in sympy: Geometric Algebra and the LaTeX Printer
Re: Issue 2087 in sympy: solver treats a nonlinear expression as linear and
mis-solves a true nonlinear system; fixed in polys11 but slow
Re: Issue 2080 in sympy: WildFunction needs to reference Dummy.dummycount
not Symbol.dummycount
Re: Issue 2085 in sympy: Limit code severely broken.
Re: Issue 2077 in sympy: classify_ode() doesn't catch a
1st_linear/separable ode
Re: Issue 2076 in sympy: intcache error
Re: Issue 2084 in sympy: limit(1+1/x, x, 0, dir='-') fails
Re: Issue 2079 in sympy: multiple integral gives wrong result
Re: Issue 2088 in sympy: (oo).evalf(chop=True) -> 0
Re: Issue 2074 in sympy: dsolve(diff(D(t), t) - k1*(B + C2*exp(-k*t) -
D(t)), D(t), 'nth_linear_constant_coeff_variation_of_parameters') gives
AttributeError: 'tuple' object has no attribute 'match'
Re: Issue 2089 in sympy: Move MediaWiki pages over to the GitHub site
Re: Issue 2078 in sympy: Solve fails or hangs on a simple pair of
simultaneous linear equations in sympy 0.6.7
Re: Issue 2082 in sympy: No SymPy class 'Composition'
Re: Issue 2072 in sympy: solve(x**(1/2)) returns []
Re: Issue 2081 in sympy: Pow substitution introduces wrong answers

sy...@googlecode.com

unread,
Apr 6, 2014, 3:13:39 AM4/6/14
to sympy-...@googlegroups.com
Your project notifications generated too many emails to send
individually. Here are the subject lines of the emails you would have
received:

Re: Issue 2782 in sympy: ReferenceFrame indices does not properly set the
indices
Re: Issue 2788 in sympy: Commented out tests should be XFAILed
Re: Issue 2786 in sympy: Fill in missing tests for sympy.physics module in
test_args.py
Re: Issue 2792 in sympy: Investigate how to employ complexity measures in
functions like trigsimp(), etc.
Re: Issue 2784 in sympy: 1/function() should be printed differently by
latex printer
Re: Issue 2778 in sympy: ``See Also`` feature in functions/special
Re: Issue 2783 in sympy: Error handling needs improvement if RigidBodies
don't have an attribute set
Re: Issue 2776 in sympy: ``See Also`` feature in integrals
Re: Issue 2779 in sympy: ``See Also`` feature in Geometry
Re: Issue 2794 in sympy: Implement ode solvers from the Moses "Stormy
Decade" paper
Re: Issue 2791 in sympy: Allow to manage slow tests better with our test
runner
Re: Issue 2781 in sympy: orientnew in sympy.physics.mechanics does not
support indices
Re: Issue 2787 in sympy: Create sticker for SymPy based on the logo
Re: Issue 2789 in sympy: minpoly should work with roots of unity in
exponential form
Re: Issue 2785 in sympy: Use \functionname instead of
\operatorname{functionname} whenever possible
Re: Issue 2780 in sympy: ``See Also`` feature in Matrices
Re: Issue 2777 in sympy: ``See Also`` feature in functions
Re: Issue 2790 in sympy: Create examples/short tutorials using IPython's
notebook (IPython >= 0.12)
Re: Issue 2775 in sympy: ``See Also`` feature in Combinatorics
Re: Issue 2793 in sympy: The dsolve solver for 1st_exact should use
integration
Re: Issue 2809 in sympy: evalf() doesn't go all the way
Re: Issue 2813 in sympy: roots(x**2 - x - 0.1) doesn't give both solutions
Re: Issue 2797 in sympy: Translate our webpage
Re: Issue 2814 in sympy: ValueError: can't raise polynomial to a negative
power with solve()
Re: Issue 2811 in sympy: Make (1/(1 - t)).subs(t, 1) return -oo instead of
oo
Re: Issue 2800 in sympy: Flesh out the SymPy Papers wiki page
Re: Issue 2808 in sympy: integrate(1/(x**2 + a**2)**2, x) is wrong if a is
real
Re: Issue 2806 in sympy: Add more tips to the tips page
Re: Issue 2803 in sympy: Investigate how to make the rewrite framework more
flexible
Re: Issue 2807 in sympy: Change .unit and .mag to proper methods and better
names.
Re: Issue 2798 in sympy: Research ways to extract statistics from the issue
tracker
Re: Issue 2802 in sympy: solve error with expression with derivative
Re: Issue 2810 in sympy: Cannot do integrate(cos(k*x)/(x**2 + a**2)/(x**2 +
b**2), (x, -oo, oo))
Re: Issue 2796 in sympy: Package the latest version of SymPy for the major
distributions
Re: Issue 2812 in sympy: Fix failures found by shuffling tests in test file
Re: Issue 2805 in sympy: Should unevaluated objects still sort their args?
Re: Issue 2799 in sympy: coverage testing should be part of the bot test
Re: Issue 2795 in sympy: Investigate a robust way to have translated
documentation
Re: Issue 2801 in sympy: lambdify() is not mentioned anywhere
Re: Issue 2804 in sympy: could_extract_minus_sign should look in the
denominator
Re: Issue 2830 in sympy: ode sol in terms of LambertW not simplified (was:
checkodesol needs to use force)
Re: Issue 2831 in sympy: bug in simplify
Re: Issue 2818 in sympy: factor() returns nan
Re: Issue 2832 in sympy: bool(Relational) should raise ValueError
Re: Issue 2817 in sympy: Make sure all the built-in __methods__ are defined
Re: Issue 2819 in sympy: simplify(sqrt(x**2)) does not yield x
Re: Issue 2833 in sympy: lambdify does not evaluate integrals
Re: Issue 2825 in sympy: Numerical Approximation to Challenging Integrals
Re: Issue 2824 in sympy: Quantum functions should all sympify their
arguments
Re: Issue 2823 in sympy: bug in fcode
Re: Issue 2822 in sympy: Move preorder_traversal to the core
Re: Issue 2827 in sympy: 2to3 conversion tool gives some errors on the GA
module
Re: Issue 2820 in sympy: expand() doesn't work in the denominator
Re: Issue 2828 in sympy: primitive() problem
Re: Issue 2815 in sympy: the plotting module does not follow PEP8 (code
formating)
Re: Issue 2821 in sympy: The test runner should convert warnings to
exceptions.
Re: Issue 2826 in sympy: Strange series behavior
Re: Issue 2816 in sympy: Regarding integration of k*(x**0)
Re: Issue 2829 in sympy: secondquant argument ordering
Re: Issue 2837 in sympy: in Sum - the subs argument of evalf does not work
Re: Issue 2851 in sympy: logcombine(log(3) - log(2)) does nothing
Re: Issue 2845 in sympy: Integrating the new plotting module
Re: Issue 2844 in sympy: integration of 1/sqrt(n-m*x^2)
Re: Issue 2848 in sympy: Failing test in sympy/solvers/test/test_solvers.py
Re: Issue 2843 in sympy: nsimplify of longs fails
Re: Issue 2842 in sympy: Fix evalf documentation
Re: Issue 2852 in sympy: is_constant(wrt) is needed
Re: Issue 2840 in sympy: sympify could delete newlines, perhaps
Re: Issue 2849 in sympy: integration of cos(x)/sin(x)**n
Re: Issue 2838 in sympy: Move KroneckerDelta out of the quantum module
Re: Issue 2846 in sympy: Integral.transform should allow a change to a
different variable
Re: Issue 2847 in sympy: Recursion error with (1/sqrt(-a**2 +
z**(-4))).series(z, 0)
Re: Issue 2850 in sympy: integration of (x**(n-1))*sqrt(1+x**n)
Re: Issue 2836 in sympy: multiple iterations through ReferenceFrame
instances return empty list
Re: Issue 2839 in sympy: there is a duplicate definition of RealSet
Re: Issue 2834 in sympy: naive radical removal can lead to multiplying by
0/0
Re: Issue 2841 in sympy: sympy.Abs and sympy.Integral
Re: Issue 2835 in sympy: PolynomialError with minpoly()
Re: Issue 2864 in sympy: Parsing issue with mathematica.py with regex
expressions
Re: Issue 2867 in sympy: Calls to raises() should use lambda
Re: Issue 2858 in sympy: Solve doesn't get all the solutions of a
polynomial system
Re: Issue 2853 in sympy: Standard sets (ZZ, QQ, RR, etc.) for the sets
module
Re: Issue 2854 in sympy: summation(exp(-l_1*i - l_2*j), (j, 0, i), (i, 0,
n)) doesn't work
Re: Issue 2856 in sympy: limit(x**16/(x**16 + 1), x, oo) fails
Re: Issue 2855 in sympy: Removing sorting of Add.args and Mul.args
Re: Issue 2868 in sympy: Create XFAIL tests for open issues
Re: Issue 2857 in sympy: sqrt(2).is_irrational is None (should be True)
Re: Issue 2869 in sympy: Document all the options to latex()
Re: Issue 2866 in sympy: Pretty printing of empty matrices
Re: Issue 2860 in sympy: IMHO limit's dir should not default to "+"
Re: Issue 2870 in sympy: SymPy-Live should save the history when logged in
Re: Issue 2861 in sympy: Two functions named div in GA.py
Re: Issue 2862 in sympy: Unknown intention in which variable to be used as
loop base in class MV
Re: Issue 2865 in sympy: str(Matrix(...)) should give "Matrix(...)"
Re: Issue 2863 in sympy: Plotting failures with SymPy-Bot
Re: Issue 2859 in sympy: Improve code coverage
Re: Issue 2883 in sympy: The installation guide should be in the Sphinx docs
Re: Issue 2882 in sympy: integration of 1/(1+x**2) works but 1/(1+u**2)
fails
Re: Issue 2879 in sympy: Use gettext for the tutorial and webpage
translations
Re: Issue 2886 in sympy: Float precision
Re: Issue 2884 in sympy: out of range matrix index doesn't raise error
Re: Issue 2878 in sympy: Add section to the Gotchas about floating point
numbers
Re: Issue 2876 in sympy: factor breaks power rules
Re: Issue 2873 in sympy: in core/decorators.py there is unneeded try,
except block
Re: Issue 2880 in sympy: segmentation fault after plotting
Re: Issue 2872 in sympy: Issues with the SymPy Live mobile interface
Re: Issue 2874 in sympy: Pretty printing at SymPy-Live doesn't work if the
window is resized
Re: Issue 2871 in sympy: Finish the SymPy Live Sphinx extension
Re: Issue 2881 in sympy: Refactory secondquant to use new quantum modules
Re: Issue 2875 in sympy: cse not working with Integral args
Re: Issue 2885 in sympy: Logging for the IRC channel
Re: Issue 2877 in sympy: Contradictory facts about infinities in the new
assumptions
Reply all
Reply to author
Forward
0 new messages