当前位置: 首页>>代码示例>>Python>>正文


Python math.f函数代码示例

本文整理汇总了Python中math.f函数的典型用法代码示例。如果您正苦于以下问题:Python f函数的具体用法?Python f怎么用?Python f使用的例子?那么恭喜您, 这里精选的函数代码示例或许可以为您提供帮助。


在下文中一共展示了f函数的15个代码示例,这些例子默认根据受欢迎程度排序。您可以为喜欢或者感觉有用的代码点赞,您的评价将有助于系统推荐出更棒的Python代码示例。

示例1: main

def main():
    size = 20
    # size 'rights' + size 'downs'
    # combinations formula
    steps = size * 2
    result = f(steps) / (f(size) * f(steps - size))
    print('Result: ', int(result))
开发者ID:asolano,项目名称:project-euler,代码行数:7,代码来源:e15.py

示例2: fixation_prob

def fixation_prob(n, m, a):
    matrix = [[0 for i in range(len(a))] for j in range(m)]
    
    # Population is diploid so number of alleles is 2N    
    n = 2*n
    
    for i in range(len(a)):
        # Frequency of each number of recessive alleles in the current pop.
        curr_gen = [0 for x in range(n+1)]
        curr_gen[a[i]] = 1
        
        # For each generatjon...
        for gen in range(m):
            next_gen = [0 for x in range(n+1)]
            
            for j in range(n+1): # frequency in next generation...
                for k in range(n+1): # frequency in current geneneration...
                    p1 = f(n) / f(j) / f(n-j) 
                    p2 = (k/n)**j * (1-(k/n))**(n-j) 
                    p3 = curr_gen[k]
                    next_gen[j] += p1 * p2 * p3
                    
            curr_gen = next_gen
            
            # Store the common logarithm of the answer.
            matrix[gen][i] = log10(curr_gen[0])

    return matrix
开发者ID:Davo36,项目名称:Rosalind-1,代码行数:28,代码来源:rosalind_FOUN.py

示例3: handle

    def handle(self, *args, **options):
        school_dict = dict()
        for m in Project.objects.filter(
            category="micro_sumo",is_confirmed=True):
            if school_dict.has_key(m.manager.school):
                school_dict[m.manager.school] += 1
            else:
                school_dict[m.manager.school] = 1
        school_pairs = school_dict.items()
        school_pairs.sort(key=lambda tup: tup[1])
        school_list = map(lambda x: x[0], school_pairs)
        robot_count = sum(school_dict.values())

        # generate groups
        if robot_count % 4 == 1:
            group_count = robot_count / 4
        elif robot_count % 4 == 2:
            group_count = robot_count / 4 + 1
        elif robot_count % 4 == 3:
            group_count = robot_count / 4 + 1
        elif robot_count % 4 == 0:
            group_count = robot_count / 4

        for i in range(1, group_count+1):
            SumoGroup.objects.create(order=i, is_final=False)

        group_list = SumoGroup.objects.filter(is_final=False)
        active_groups = list(group_list)
        passive_groups = list()
        shuffle(active_groups)

        for school in school_list:
            for m in Project.objects.filter(
                    category="micro_sumo",
                    manager__school=school, is_confirmed=True):
                if len(active_groups) == 0:
                    active_groups = passive_groups[:]
                    shuffle(active_groups)
                    passive_groups = list()
                current_group = active_groups.pop()
                passive_groups.append(current_group)
                SumoGroupTeam.objects.create(
                    group=current_group, robot=m)
        self.stdout.write('Sumo groups generated.')

        for group in SumoGroup.objects.all():
            order = 1
            teams = SumoGroupTeam.objects.filter(group=group)
            team_list = list(teams)
            count = len(team_list)
            for j in range(f(count) / f(2) / f(count-2) / 2):
                for i in range(0, len(team_list) / 2):
                    SumoGroupMatch.objects.create(
                        home=team_list[i].robot,
                        away=team_list[len(team_list) - i - 1].robot,
                        group=group, order=order)
                    order += 1
                hold = team_list.pop()
                team_list.insert(1, hold)
        self.stdout.write("Fixtures generated.")
开发者ID:alperkesen,项目名称:ituro,代码行数:60,代码来源:generategroups.py

示例4: perms

def perms(alist):
    acounter = Counter(alist)
    n = len(alist)
    ans = f(n)
    for key in acounter:
        ans /= f(acounter[key])
    return ans
开发者ID:laveesingh,项目名称:Competitive-Programming,代码行数:7,代码来源:main.py

示例5: pure_py

def pure_py(xyz, Snlm, Tnlm, nmax, lmax):
    from scipy.special import lpmv, gegenbauer, eval_gegenbauer, gamma
    from math import factorial as f

    Plm = lambda l,m,costh: lpmv(m, l, costh)
    Ylmth = lambda l,m,costh: np.sqrt((2*l+1)/(4 * np.pi) * f(l-m)/f(l+m)) * Plm(l,m,costh)

    twopi = 2*np.pi
    sqrtpi = np.sqrt(np.pi)
    sqrt4pi = np.sqrt(4*np.pi)

    r = np.sqrt(np.sum(xyz**2, axis=0))
    X = xyz[2]/r # cos(theta)
    sinth = np.sqrt(1 - X**2)
    phi = np.arctan2(xyz[1], xyz[0])
    xsi = (r - 1) / (r + 1)

    density = 0
    potenti = 0
    gradien = np.zeros_like(xyz)
    sph_gradien = np.zeros_like(xyz)
    for l in range(lmax+1):
        r_term1 = r**l / (r*(1+r)**(2*l+3))
        r_term2 = r**l / (1+r)**(2*l+1)
        for m in range(l+1):
            for n in range(nmax+1):
                Cn = gegenbauer(n, 2*l+3/2)
                Knl = 0.5 * n * (n+4*l+3) + (l+1)*(2*l+1)
                rho_nl = Knl / twopi * sqrt4pi * r_term1 * Cn(xsi)
                phi_nl = -sqrt4pi * r_term2 * Cn(xsi)

                density += rho_nl * Ylmth(l,m,X) * (Snlm[n,l,m]*np.cos(m*phi) +
                                                    Tnlm[n,l,m]*np.sin(m*phi))
                potenti += phi_nl * Ylmth(l,m,X) * (Snlm[n,l,m]*np.cos(m*phi) +
                                                    Tnlm[n,l,m]*np.sin(m*phi))

                # derivatives
                dphinl_dr = (2*sqrtpi*np.power(r,-1 + l)*np.power(1 + r,-3 - 2*l)*
                              (-2*(3 + 4*l)*r*eval_gegenbauer(-1 + n,2.5 + 2*l,(-1 + r)/(1 + r)) +
                              (1 + r)*(l*(-1 + r) + r)*eval_gegenbauer(n,1.5 + 2*l,(-1 + r)/(1 + r))))
                sph_gradien[0] += dphinl_dr * Ylmth(l,m,X) * (Snlm[n,l,m]*np.cos(m*phi) +
                                                              Tnlm[n,l,m]*np.sin(m*phi))

                A = np.sqrt((2*l+1) / (4*np.pi)) * np.sqrt(gamma(l-m+1) / gamma(l+m+1))
                dYlm_dth = A / sinth * (l*X*Plm(l,m,X) - (l+m)*Plm(l-1,m,X))
                sph_gradien[1] += (1/r) * dYlm_dth * phi_nl * (Snlm[n,l,m]*np.cos(m*phi) +
                                                               Tnlm[n,l,m]*np.sin(m*phi))

                sph_gradien[2] += (m/(r*sinth)) * phi_nl * Ylmth(l,m,X) * (-Snlm[n,l,m]*np.sin(m*phi) +
                                                                           Tnlm[n,l,m]*np.cos(m*phi))

    cosphi = np.cos(phi)
    sinphi = np.sin(phi)
    gradien[0] = sinth*cosphi*sph_gradien[0] + X*cosphi*sph_gradien[1] - sinphi*sph_gradien[2]
    gradien[1] = sinth*sinphi*sph_gradien[0] + X*sinphi*sph_gradien[1] + cosphi*sph_gradien[2]
    gradien[2] = X*sph_gradien[0] - sinth*sph_gradien[1]

    return density, potenti, gradien
开发者ID:adrn,项目名称:gala,代码行数:58,代码来源:test_bfe.py

示例6: solve

def solve(fname):
    v,c = read_connections(fname)
    c = sorted(c,key=lambda x:x[2])
    from math import factorial as f
    n = len(c)
    print(f(n)/f(n-v+1)/f(v-1))
    for subset in itertools.combinations(c,v-1):
        if fully_connected(v,subset):
            return weight(c)-weight(subset)
开发者ID:joeyuan19,项目名称:ProjectEuler,代码行数:9,代码来源:107.py

示例7: surprise_value

def surprise_value(ss):
    from dist import simple_dist
    from math import factorial as f
    if len(ss) < 2: return 0

    l = len(ss)
    nC2 = f(l) / 2 / f(l-2)
    total_dist = sum(simple_dist(a,b) for (a,b) in itertools.combinations(ss,2))
    return total_dist / nC2
开发者ID:sirosen,项目名称:CompLinguistics,代码行数:9,代码来源:anagrams.py

示例8: cntMatrix

 def cntMatrix(self, A):
     # determine how far columns are sorted
     N, count = len(A), 0
     for i in xrange(1, N + 1):
         if N % i == 0:
             # check if all i chunks of array are sorted
             if self.chunkSortedChecker(i, A):
                 print 'For i: ', i,  pow(f(i), N / i, mod)
                 count += pow(f(i), N / i, mod)
     return count % mod
开发者ID:isopropylcyanide,项目名称:chal,代码行数:10,代码来源:distinctMat.py

示例9: bp_prob

def bp_prob(s, a, b, k):
    n = len(s)
    N = count_kmers(s, 1)
    nn = [(i[1], i[0] in [a,b]) for i in N.items()]
    
    if k > min(N[a],N[b]) or k < 0: 
        return 0 
    
    ns = sum([( f(n-j) / ( reduce(lambda x,y: x*( f(y[0] - (j if y[1] else 0) ) ) , nn, 1) * f(j-k) * f(k) ) ) * (-1)**(j-k)\
              for j in range(k,min(N[a],N[b])+1)])
    
    return (ns / ( f(n) / ( reduce(lambda x,y: x*f(y[0]) , nn, 1) ) / 10**100   )   )*(10.0**(-100))
开发者ID:zidarsk8,项目名称:bio,代码行数:12,代码来源:homework1.py

示例10: getPermutation

 def getPermutation(self, n, k):
     from math import factorial as f
     nums = range(1, n + 1)
     result = ''
     for i in range(n):
         q, r = k / f(n - 1 - i), k % f(n - 1 - i)
         if r > 0:
             q += 1
         result += str(nums[q - 1])
         nums.remove(nums[q - 1])
         k = r
     return result
开发者ID:xingyuanp,项目名称:LeeCodeOJ,代码行数:12,代码来源:permutation_sequence.py

示例11: solve_equation

def solve_equation(a, b, c):
    d = b * b - 4 * a * c
    if d > 0:
        x1 = (-b + f(d)) / (2 * a)
        x2 = (-b - f(d)) / (2 * a)
        return x1, x2
    elif d == 0:
        x = -b / (2 * a)
        return x, x
    else:
        x1 = complex(-b / (2 * a), f(-d) / (2 * a))
        x2 = complex(-b / (2 * a), -f(-d) / (2 * a))
        return x1, x2
开发者ID:live-imagine,项目名称:itis-django-3k-1s-2015,代码行数:13,代码来源:useful_functions.py

示例12: factorial_digits

def factorial_digits(x):
    x = str(x)
    total = 0
    for c in x:
        total += f(int(c))

    return total
开发者ID:adamrodger,项目名称:eulerproblems,代码行数:7,代码来源:prob074-slow.py

示例13: foo

def foo(num):
	a=[num]
	while 1:
		tmp=sum([f(int(i)) for i in list(str(a[-1]))])
		if tmp in a: break
		a.append(tmp)
	return len(a)
开发者ID:Urinx,项目名称:Project_Euler_Answers,代码行数:7,代码来源:074.py

示例14: ncr

def ncr(n,r):
    a = max(n-r,r)
    b = min(n-r,r)
    fac = 1
    while n>a:
        fac *= n
        n -= 1
    return fac/f(b)
开发者ID:saikiran03,项目名称:competitive,代码行数:8,代码来源:marbles.py

示例15: main

def main():
    # the max that we can reach is 9! * the number of digits
    i = 1
    lim = f(9)
    while lim * i > pow(10, i):
        i += 1
    lim *= i

    return sum([n for n in xrange(lim + 1) if is_factorian(n)])
开发者ID:willcodefortea,项目名称:ProjectEuler,代码行数:9,代码来源:034.py


注:本文中的math.f函数示例由纯净天空整理自Github/MSDocs等开源代码及文档管理平台,相关代码片段筛选自各路编程大神贡献的开源项目,源码版权归原作者所有,传播和使用请参考对应项目的License;未经允许,请勿转载。