forked from OpenGenus/cosmos-search
-
Notifications
You must be signed in to change notification settings - Fork 0
/
Copy pathmetadata.json
1 lines (1 loc) · 54.5 KB
/
metadata.json
1
{"code/artificial_intelligence/decision_tree": ["data_banknote_authentication.csv", "Decision_Tree.py"], "code/artificial_intelligence/factorization_machines": ["README.md"], "code/artificial_intelligence/gaussian_mixture_model": ["README.md"], "code/artificial_intelligence/gradient_boosting_trees": ["README.md"], "code/artificial_intelligence/hierachical-clustering": ["hierachical_clustering.cpp", "README.md"], "code/artificial_intelligence/k_means": ["k_means.cpp", "k_means.py", "k_means.swift", "README.md"], "code/artificial_intelligence/k_Nearest_Neighbours": ["iris.data", "k_Nearest_Neighbours.py"], "code/artificial_intelligence/Linear_Regression": ["linear_regression.py", "linear_regression.swift", "LinearRegression.java", "linearRegression.js", "README.md"], "code/artificial_intelligence/Logistic_Regression": ["Logistic_Regression.py", "README.md"], "code/artificial_intelligence/naive_bayes": ["naive_bayes.swift", "README.md"], "code/artificial_intelligence/neural_network": ["neuralnetwork.py"], "code/artificial_intelligence/principal_component_analysis": ["pca.py", "README.md"], "code/artificial_intelligence/q_learning": ["qLearning.js", "README.md"], "code/artificial_intelligence/random_forests": ["README.md"], "code/artificial_intelligence/restricted_boltzmann_machine": ["README.md"], "code/artificial_intelligence/SAT": ["togasat.cpp"], "code/artificial_intelligence/support_vector_machine": ["README.md"], "code/artificial_intelligence/t_distributed_stochastic_neighbor_embedding": ["README.md"], "code/artificial_intelligence/TSP": ["algo.md", "euc_100", "euc_250", "euc_500", "Makefile", "noneuc_100", "noneuc_250", "noneuc_500", "salesman.cpp"], "code/backtracking/algorithm-x": ["algo-x.cpp", "README.md"], "code/backtracking/crossword_puzzle": ["CrosswordPuzzle.java"], "code/backtracking/knight_tour": ["knight_tour.c", "knight_tour.cpp", "knight_tour.go", "knight_tour.java", "knight_tour.py", "knight_tour.rs", "knight_tour_withoutBT.c", "README.md"], "code/backtracking/n_queen": ["n _queen.c", "nqueen.go", "nQueen.hs", "NQueen.java", "nqueen.py", "NQueen_Backtracking.cpp", "Nqueen_Backtracking.rs", "nqueen_bit.go", "NQueen_BitImp.cpp", "NQueen_Bitset.cpp", "README.md"], "code/backtracking/number_of_ways_in_maze": ["no_of_ways_in_maze.go", "no_of_ways_in_maze.java", "no_of_ways_in_maze.rs", "noOfWaysinMaze.c", "number_of_ways_in_maze.cpp", "README.md"], "code/backtracking/partitions_of_number": ["partitions_of_number.cpp", "partitions_of_number.go", "partitions_of_number.rs", "README.md"], "code/backtracking/partitions_of_set": ["README.md", "set_partitions.cpp", "set_partitions.go"], "code/backtracking/permutations_of_string": ["permutations_of_string.c", "permutations_of_string.go", "permutations_of_string.kt", "permutations_of_string.py", "permutations_of_string_itertools.py", "permutations_of_string_stl.cpp", "README.md"], "code/backtracking/powerset": ["powerset.go", "PowerSet.java"], "code/backtracking/rat_in_a_maze": ["rat_in_a_maze.cpp", "README.md"], "code/backtracking/subset_sum": ["README.md", "Subset_Sum.c", "subset_sum.cpp", "subset_sum.go", "Subset_Sum_Duplicates.py", "SubsetSum.java", "SubsetSum.py"], "code/backtracking/sudoku_solve": ["README.md", "sudoku_solve.py", "SudokuSolve.c", "SudokuSolve.cpp"], "code/bit-manipulation/bit_division": ["bitDivision.c", "bitDivision.go", "BitDivision.java", "bitDivision.js", "bitDivison.py", "README.md"], "code/bit-manipulation/byte_swapper": ["ByteSwapper.java"], "code/bit-manipulation/convert_number_binary": ["binary_to_int.py", "convert_number_binary.c", "convert_number_binary.cpp", "convert_number_binary.hs", "convert_number_binary.js", "convert_number_binary.php", "ConvertNumberBinary.java", "intToBinary.py", "README.md"], "code/bit-manipulation/count_set_bits": ["count_set_bits.c", "count_set_bits.cpp", "count_set_bits.py", "count_set_bits_lookup_table.cpp", "CountSetBits.java", "countSetBits.js", "README.md"], "code/bit-manipulation/flip_bits": ["FlipBits.java", "flippingbits.c", "flippingbits.cpp", "flippingbits.py", "README.md"], "code/bit-manipulation/hamming_distance": ["hamming_distance.c", "hamming_distance.cpp", "hamming_distance.java", "hamming_distance.py", "hamming_distance2.py", "README.md"], "code/bit-manipulation/lonely_integer": ["lonely_integer.rs", "LonelyInt.java", "LonelyInt.js", "LonelyInteger.c", "lonelyInteger.cpp", "lonelyInteger.go", "lonelyInteger.py", "README.md"], "code/bit-manipulation/magic_number": ["magic_number.c", "magic_number.java", "magic_number.py", "nth_magic_number.cpp", "README.md"], "code/bit-manipulation/maximum_xor_value": ["max_xor_value.cpp", "README.md"], "code/bit-manipulation/power_of_2": ["power_of_2.c", "power_of_2.cpp", "power_of_2.go", "power_of_2.jl", "power_of_2.js", "power_of_2.py", "power_of_2.rs", "PowerOf2.cs", "PowerOf2.java"], "code/bit-manipulation/subset_generation": ["README.md", "subset_mask_generator.cpp", "subsetgeneratorusingbit.cpp", "subsetsum.cpp"], "code/bit-manipulation/sum_binary_numbers": ["README.md", "sum_binary_numbers.c"], "code/bit-manipulation/sum_equals_xor": ["README.md", "sum_equals_xor.c", "sum_equals_xor.cpp"], "code/bit-manipulation/thrice_unique_number": ["README.md", "threeUnique.cpp", "thrice_unique_number.js", "ThriceUniqueNumber.java", "uniqueNumber.py"], "code/bit-manipulation/twice_unique_number": ["README.md", "two_Unique_Numbers.c", "twoUniqueNumbers.cpp"], "code/bit-manipulation/xor_swap": ["README.md", "xor_swap.c"], "code/cellular_automaton/brians_brain": ["README.md"], "code/cellular_automaton/conways_game_of_life": ["Conway.java", "conways_game_of_life.rb", "game_of_life_C_SDL.c", "GameOfLife.hs", "life.c", "life.cpp", "life.go", "life.py", "README.md"], "code/cellular_automaton/elementary_cellular_automata": ["ElementaryCellularAutomaton.java", "README.md"], "code/cellular_automaton/genetic_algorithm": ["genetic.cpp", "genetic_algorithm.go", "genetic_algorithm.java", "genetic_algorithm.js", "genetic_algorithm.py", "genetic_algorithm2.py"], "code/cellular_automaton/langtons_ant": ["LangtonAnt.cpp", "LangtonAnt.html", "LangtonAnt.java", "LangtonAnt.py", "README.md"], "code/cellular_automaton/nobili_cellular_automata": ["README.md"], "code/cellular_automaton/von_neumann_cellular_automata": ["README.md"], "code/compression/lossless_compression/huffman": ["huffman.cpp", "huffman.test.cpp", "README.md"], "code/compression/lossless_compression/lempel-ziv-welch": ["lzw.cpp", "lzw.py", "README.md"], "code/compression/lossy_compression": ["README.md"], "code/computational_geometry/2d_line_intersection": ["line.c", "line.cpp", "line.cs", "line.java", "line.js", "line.py", "line.rb", "line2dintersection.hs", "README.md"], "code/computational_geometry/2d_separating_axis_test": ["sat.cpp"], "code/computational_geometry/area_of_polygon": ["area_of_polygon.c", "area_of_polygon.cpp", "area_of_polygon.py", "AreaOfPolygon.java"], "code/computational_geometry/area_of_triangle": ["area_of_triangle.cpp", "area_of_triangle.go", "area_of_triangle.js", "area_of_triangle.py", "area_of_triangle.rs", "AreaOfTriangle.java"], "code/computational_geometry/axis_aligned_bounding_box_collision": ["axis_aligned_bounding_box_collision.cpp", "axis_aligned_bounding_box_collision.go"], "code/computational_geometry/bresenham_line": ["bresenham_line.py", "bresenhams_line.cpp"], "code/computational_geometry/cohen_sutherland_lineclip": ["lineclip.c", "README.md"], "code/computational_geometry/distance_between_points": ["distance_between_points.c", "distance_between_points.cpp", "distance_between_points.go", "distance_between_points.js", "distance_between_points.py", "distance_between_points.rs", "DistanceBetweenPoints.java", "README.md"], "code/computational_geometry/graham_scan": ["graham_scan.cpp", "GrahamScan.java"], "code/computational_geometry/halfplane_intersection": ["halfplane_intersection.cpp"], "code/computational_geometry/jarvis_march": ["jarvis_march.cpp"], "code/computational_geometry/quickhull": ["quickhull.cpp", "quickhull.hs", "quickHull.java", "README.md", "test_data.csv", "test_data_soln.png", "test_data_soln.txt"], "code/computational_geometry/sutherland_hodgeman_clipping": ["README.md", "sutherland.c", "sutherland.cpp"], "code/cryptography/aes_128": ["aes_128.cpp", "AES_128.py"], "code/cryptography/affine_cipher": ["affine.cpp", "affine.htm", "Affine.java", "affine.py", "affine_cipher.py"], "code/cryptography/atbash_cipher": ["atbash_cipher.cpp", "atbash_cipher.py", "README.md"], "code/cryptography/autokey_cipher": ["autokey.py"], "code/cryptography/baconian_cipher": ["baconian.php", "baconian.py", "baconian.rb", "README.md"], "code/cryptography/caesar_cipher": ["caesar.c", "caesar.go", "caesar.py", "caesar.rb", "caesar_cipher.cpp", "caesar_cipher.java", "caesar_cipher.js", "caesar_cipher.php", "CaesarCipher.cs", "casesar.hs", "decryption.cpp", "encryption.cpp", "README.md"], "code/cryptography/columnar_transposition_cipher": ["columnar_transposition.cpp"], "code/cryptography/huffman_encoding": ["huffman_encoding.c"], "code/cryptography/morse_cipher": ["morse-code-translator.js", "morse_code_generator.bf", "morse_code_generator.c", "morse_code_generator.cpp", "morse_code_generator.rb", "morse_code_translator.cpp", "morse_code_translator.php", "morse_code_translator.py", "morse_code_translator.ts", "MorseCode.java", "morsecode.sh", "morseCode_translator.lua", "README.md"], "code/cryptography/polybius_cipher": ["polybius.py"], "code/cryptography/porta_cipher": ["porta.py"], "code/cryptography/rail_fence_cipher": ["rail_fence.cpp", "rail_fence.py", "rail_fence.rb"], "code/cryptography/rot13_cipher": ["README.md", "rot13.cpp", "rot13.js", "rot13.py", "rot13.rb", "rot13.sh", "rotN.c", "rotN.cpp", "rotN.java", "rotN.js"], "code/cryptography/rsa": ["rsa.c", "RSA.java", "rsa.py", "rsa_input.in"], "code/cryptography/rsa_digital_signature": ["rsa_digital_signature.ipynb"], "code/cryptography/runningkey_cipher": ["runningkey.py"], "code/cryptography/vigenere_cipher": ["README.md", "vigenere.go", "vigenere_cipher.c", "vigenere_cipher.hs", "vigenere_cipher.java", "vigenere_cipher.jl", "vigenere_cipher.js", "vigenere_cipher.php", "vigenere_cipher.py", "vigenere_cipher.rb", "vigenere_cypher.cpp"], "code/data_structures/aa_tree": ["aa_tree.cpp", "README.md"], "code/data_structures/avl_tree": ["avl_tree.cpp", "avl_tree.java", "avl_tree.swift"], "code/data_structures/b_tree/b_tree_C": ["btree.c", "btree.h", "main.c", "README.md"], "code/data_structures/bag": ["bag.java", "bag.js", "bag.py"], "code/data_structures/binomial_heap": ["binomial_heap.c", "binomial_heap.cpp", "BinomialHeap.scala"], "code/data_structures/bloom_filter": ["bloom_filter.c", "bloom_filter.cpp", "bloom_filter.js", "bloom_filter.py", "bloom_filter.swift", "BloomFilter.java", "BloomFilter.scala"], "code/data_structures/fenwick_tree": ["fenwick_tree.c", "fenwick_tree.cpp", "fenwick_tree.go", "fenwick_tree.java", "fenwick_tree.pl", "fenwick_tree.py", "fenwick_tree_inversion_count.cpp", "README.md"], "code/data_structures/hash_table": ["double_hashing.c", "hash_table.c", "hash_table.cpp", "hash_table.cs", "hash_table.go", "hash_table.java", "hash_table.js", "HashTable.swift", "README.md"], "code/data_structures/heap/max_heap": ["max_heap.c", "max_heap.cpp", "max_heap.go", "max_heap.java", "max_heap.py"], "code/data_structures/heap/min_heap": ["min_heap.cpp", "min_heap.java", "min_heap.py", "min_heap.rb", "min_heap.swift", "minheap.cpp", "minheap.js"], "code/data_structures/heap/priority_queue": ["priority_queue.py", "priorityQueue.js", "README.md"], "code/data_structures/interval_tree": ["interval_tree.cpp", "interval_tree.java", "README.md"], "code/data_structures/kd_tree": ["kd_tree.cpp", "kd_tree.java"], "code/data_structures/leftist_tree": ["leftist_priority_queue.cpp"], "code/data_structures/linked_list/circular_linked_list": ["circular_linked_list.cpp", "circular_linked_list.java", "circular_linked_list.py", "has_loop.py"], "code/data_structures/linked_list/doubly_linked_list": ["doubly_linked_list.c", "doubly_linked_list.cpp", "doubly_linked_list.go", "doubly_linked_list.h", "doubly_linked_list.js", "doubly_linked_list.py", "doubly_linked_list.swift", "DoublyLinkedList.java"], "code/data_structures/linked_list/linked_list": ["linked_list.c", "linked_list.cs", "linked_list.go", "linked_list.py", "linked_list.rb", "linked_list.swift", "single_linked_list_with_3_nodes.java", "singly_linked_list.cpp", "singly_linked_list.js", "singly_linked_list_with_classes.cpp", "SinglyLinkedList.java"], "code/data_structures/linked_list/linked_lists_operations/n_th_node_linked_list": ["nth_node_from_end.c", "nthNodeFromEnd.cpp"], "code/data_structures/pairing_heap": ["pairing_heap.fs", "pairing_heap.sml", "README.md"], "code/data_structures/quad_tree": ["quad_tree.swift"], "code/data_structures/queue/circular_buffer": ["circular_buffer.cpp", "circular_buffer.py"], "code/data_structures/queue/queue": ["queue.c", "queue.cpp", "queue.cs", "queue.go", "queue.java", "queue.js", "queue.py", "queue.rb", "queue.swift", "queue_vector.cpp", "README.md"], "code/data_structures/queue/queue_stream": ["queue_stream.cs"], "code/data_structures/queue/queue_using_linked_list": ["queue_using_linked_list.c", "queue_using_linked_list.cpp", "queue_using_linked_list.java", "queue_using_linked_list.py", "queue_using_linked_list.rb", "README.md"], "code/data_structures/queue/queue_using_stack": ["queue_using_stack.cpp", "queue_using_stack.java", "queue_using_stack.sh"], "code/data_structures/queue/reverse_queue": ["reverse_queue.cpp", "reverse_queue.go", "reverse_queue.java", "reverse_queue.py", "reverse_queue.swift"], "code/data_structures/red_black_tree": ["RBTree.scala", "red_black_test.c", "red_black_tree.c", "red_black_tree.cpp", "red_black_tree.h", "red_black_tree.java", "red_black_tree.rb", "red_black_tree.test.cpp"], "code/data_structures/rope": ["rope.py"], "code/data_structures/segment_tree": ["lazy_segment_tree.java", "persistent_segment_tree_sum.cpp", "README.md", "segment_tree.java", "segment_tree_kth_statistics_on_segment.cpp", "segment_tree_lazy_propagation.cpp", "segment_tree_rmq.cpp", "segment_tree_rmq.go", "segment_tree_rmq.py", "segment_tree_sum.cpp", "segment_tree_sum.go", "segment_tree_sum.py", "segment_tree_sum.rb", "SegmentTree.scala"], "code/data_structures/skip_list": ["skip_list.c", "skip_list.cpp", "skip_list.java", "skip_list.scala", "skip_list.swift"], "code/data_structures/soft_heap": ["soft_heap.cpp"], "code/data_structures/splay_tree": ["readme.md", "splay_tree.cpp", "splay_tree.go", "splay_tree.java", "splay_tree.kt", "splay_tree.scala"], "code/data_structures/stack/abstract_stack/cpp/arrayStack": ["ArrayStack.h", "arraystackTester.cpp"], "code/data_structures/stack/balanced_expression": ["balanced_expression.java"], "code/data_structures/stack/infix_to_postfix": ["infix_to_postfix.c", "infix_to_postfix.cpp", "infix_to_postfix.java", "infix_to_postfix.py", "README.md"], "code/data_structures/stack/postfix_evaluation": ["infix_to_postfix_evaluation.cpp", "postfix_evaluation.c", "postfix_evaluation.sh", "README.md"], "code/data_structures/stack/prefix_to_postfix": ["prefix_to_postfix.py", "README.md"], "code/data_structures/stack/reverse_stack": ["README.md", "reverse_stack.c", "reverse_stack.cs", "reverse_stack.go", "reverse_stack.java", "reverse_stack.py", "reverse_stack.swift", "reverse_stack_without_extra_space.cpp"], "code/data_structures/stack/sort_stack": ["README.md", "sort_stack.c", "sort_stack.cpp"], "code/data_structures/stack/stack": ["README.md", "stack.c", "stack.cpp", "stack.cs", "stack.erl", "stack.ex", "stack.go", "stack.java", "stack.js", "stack.php", "stack.py", "stack.rb", "stack.rs", "stack.swift"], "code/data_structures/suffix_array": ["suffix_array.cpp"], "code/data_structures/treap": ["persistent_treap.kt", "treap.cpp", "treap.java", "treap.scala", "treap.swift"], "code/data_structures/tree/binary_search_tree": ["binary_search_tree.c", "binary_search_tree.cpp", "binary_search_tree.go", "binary_search_tree.java", "binary_search_tree.js", "binary_search_tree.py", "binary_search_tree.rb", "binary_search_tree.swift", "README.md"], "code/data_structures/tree/binary_tree/bottom_view_binary_tree": ["bottom_view_binary_tree.cpp", "bottom_view_binary_tree.java"], "code/data_structures/tree/binary_tree_diameter": ["b_tree_diameter.cpp", "binary_tree_diameter.c", "binary_tree_diameter.cpp", "binary_tree_diameter.hs", "binary_tree_diameter.java", "binary_tree_diameter.py", "diameter_tree.c", "README.md"], "code/data_structures/tree/binary_tree_maximum_height": ["binary_tree_maximum_height.java", "binary_tree_maximum_height.py", "binary_tree_maximum_height_1.cpp", "binary_tree_maximum_height_2.cpp", "README.md"], "code/data_structures/tree/binary_tree_minimum_height": ["binary_tree_minimum_height.c", "binary_tree_minimum_height.cpp", "binary_tree_minimum_height.java", "binary_tree_minimum_height.py", "README.md"], "code/data_structures/tree/binary_tree_mirror": ["binary_tree_mirror.cpp", "binary_tree_mirror.py", "mirror_image.c", "README.md"], "code/data_structures/tree/binary_tree_to_doubly_linked_list": ["binary_tree_to_DLL.cpp"], "code/data_structures/tree/check_balanced_binary_tree": ["check_balanced_binary_tree.java", "is_binary_search_tree.cpp", "README.md"], "code/data_structures/tree/inorder_and_preorder_to_postorder": ["inorder_and_preorder_to_postorder.c", "inorder_and_preorder_to_postorder.cpp", "README.md"], "code/data_structures/tree/left_view_binary_tree": ["left_view_binary_tree.java"], "code/data_structures/tree/make_tree_from_inorder_and_preorder": ["make_tree_from_inorder_and_preorder.java", "README.md"], "code/data_structures/tree/right_threaded_binary_tree": ["right_threaded_binary_tree.cpp"], "code/data_structures/tree/right_view_binary_tree": ["README.md", "right_view.cpp", "right_view_binary_tree.cpp", "right_view_binary_tree.py"], "code/data_structures/tree/sum_left_leaves": ["README.md", "sum_left_leaves.c"], "code/data_structures/trie": ["trie.c", "trie.cpp", "trie.cs", "trie.java", "trie.py", "trie.rb", "trie.scala", "trie.swift"], "code/data_structures/two_three_tree": ["TwoThreeTree.scala"], "code/data_structures/union_find": ["README.md", "union_find.c", "union_find.cpp", "union_find.go", "union_find.java", "union_find.js", "union_find.py", "union_find.scala"], "code/data_structures/van_emde_boas_tree": ["van_emde_boas.cpp"], "code/design_pattern/observer_pattern": ["observer_pattern.cpp", "observer_pattern.rs"], "code/design_pattern/singleton_pattern": ["SingletonPattern.cpp", "SingletonPattern.java"], "code/divide_conquer/closest_pair_of_points": ["closest_pair.cpp", "closest_pair.py"], "code/divide_conquer/inversion_count": ["count_inversions.c", "inversion_count.cpp", "inversion_count.java", "inversion_count.js", "inversion_count.py", "README.md"], "code/divide_conquer/karatsuba_multiplication": ["multiply.java"], "code/divide_conquer/merge_sort_using_divide_and_conquer": ["inversions.c", "merge_sort_usingDandC.cpp", "MergeSort.java", "README.md"], "code/divide_conquer/quick_sort": ["quick_sort.c", "quick_sort.cpp", "quick_sort.hs", "quick_sort.py", "quick_sort.rs", "quick_sort.swift", "quick_sort2.cpp", "quick_sort_java", "README.md"], "code/divide_conquer/warnock_algorithm": ["warnock_algorithm.pde"], "code/dynamic_programming/Array_Median": ["Median.java", "median.php", "median.py", "median.rb", "median.rs"], "code/dynamic_programming/binomial_coefficient": ["binomial_coefficient.c", "binomial_coefficient.cpp", "binomial_coefficient.java", "binomial_coefficient.py", "README.md"], "code/dynamic_programming/boolean_parenthesization": ["boolean_parenthesization.c", "boolean_parenthesization.cpp", "boolean_parenthesization.java", "boolean_parenthesization.py", "README.md"], "code/dynamic_programming/box_stacking": ["box_stacking.cpp", "box_stacking.py", "BoxStacking.java", "README.md"], "code/dynamic_programming/coin_change": ["coin_change.java", "coin_change.py", "coinchange.c", "coinchange.cpp", "coinchange.go", "mincoinchange.cpp", "README.md"], "code/dynamic_programming/edit_distance": ["edit_distance.c", "edit_distance.cpp", "edit_distance.go", "edit_distance.hs", "edit_distance.java", "edit_distance.py", "edit_distance_backtracking.cpp", "edit_distance_hirschberg.cpp", "README.md"], "code/dynamic_programming/egg_dropping_puzzle": ["egg_dropping.py", "egg_dropping_puzzle.cpp", "eggDropping.hs", "README.md"], "code/dynamic_programming/factorial": ["factorial.go", "factorial.java", "factorial.py", "factorial.scala"], "code/dynamic_programming/knapsack": ["knapsack.c", "knapsack.cpp", "knapsack.go", "Knapsack.java", "knapsack.js", "knapsack.py", "README.md"], "code/dynamic_programming/largest_sum_contiguous_subarray": ["largest_sum_contiguous_subarray.cpp", "largest_sum_contiguous_subarray.hs", "largest_sum_contiguous_subarray.java", "largest_sum_contiguous_subarray.py", "README.md"], "code/dynamic_programming/longest_bitonic_sequence": ["longest_bitonic_sequence.c", "longest_bitonic_sequence.js", "longest_bitonic_sequence.py", "longestBitonicSeq.cpp", "longestBitonicSequence.java", "README.md"], "code/dynamic_programming/longest_common_increasing_subsequence": ["longest_common_increasing_subsequence.cpp"], "code/dynamic_programming/longest_common_subsequence": ["longest_common_subsequence.cpp", "Longest_Common_Subsequence.py", "longestCommonSubsequence.go", "LongestCommonSubsequence.java", "LongestCommonSubsequenceRec.java", "README.md"], "code/dynamic_programming/longest_common_substring": ["longest_common_substring.cpp"], "code/dynamic_programming/longest_increasing_subsequence": ["longest_increasing_subsequence.c", "longest_increasing_subsequence.cpp", "longest_increasing_subsequence.go", "longest_increasing_subsequence.java", "longest_increasing_subsequence.js", "longest_increasing_subsequence.py", "longest_increasing_subsequence_using_segment_tree.cpp", "README.md"], "code/dynamic_programming/longest_independent_set": ["README.md"], "code/dynamic_programming/longest_palindromic_sequence": ["longest_palindromic_sequence.c", "longest_palindromic_sequence.cpp", "longest_palindromic_sequence.js", "longest_palindromic_sequence.py", "README.md"], "code/dynamic_programming/longest_palindromic_substring": ["LongestPalindromicSubstring.cpp", "README.md"], "code/dynamic_programming/matrix_chain_multiplication": ["matrix_chain_multiplication.c", "matrix_chain_multiplication.cpp", "matrix_chain_multiplication.py", "MatrixChainMultiplication.java", "README.md"], "code/dynamic_programming/maximum_sum_increasing_subsequence": ["maximum_sum_increasing_subsequence.c", "README.md"], "code/dynamic_programming/maximum_sum_sub_matrix": ["MaximumSubMatrixSum.java", "MaxSumSubMatrix.cpp"], "code/dynamic_programming/min_cost_path": ["min_cost_path.cpp", "min_cost_path.java", "min_cost_path.py", "README.md"], "code/dynamic_programming/minimum_cost_polygon_triangulation": ["README.md"], "code/dynamic_programming/minimum_insertion_palindrome": ["minimum_insertions_palindrome_using_lcs.cpp"], "code/dynamic_programming/minimum_insertions_palindrome": ["minimum_insertions_palindrome.cpp"], "code/dynamic_programming/no_consec_ones": ["no_consec_1.cpp", "no_consec_ones.py", "README.md"], "code/dynamic_programming/palindrome_partition": ["palindrome_partition.cpp", "palindrome_partition.js", "README.md"], "code/dynamic_programming/rod_cutting": ["README.md", "rod_cutting.cpp", "rod_cutting.hs", "rod_cutting.py"], "code/dynamic_programming/shortest_common_supersequence": ["README.md", "SCS.java", "shortest_common_supersequence.cpp", "shortest_common_supersequence.py"], "code/dynamic_programming/subset_sum": ["README.md", "subset_sum.cpp", "subset_sum.go", "subset_sum.java", "subset_sum.py"], "code/dynamic_programming/tiling_problem": ["README.md", "tiling.cpp", "tiling.py"], "code/dynamic_programming/weighted_job_scheduling": ["README.md", "weighted_job_scheduling.cpp"], "code/graph-algorithms/astar_algorithm": ["astar.js"], "code/graph-algorithms/bellman_ford_algorithm": ["bellman_ford.c", "bellman_ford.cpp", "bellman_ford.php", "bellman_ford.py", "BellmanFordAdjacencyList.java", "BellmanFordEdgeList.java", "README.md"], "code/graph-algorithms/biconnected_components": ["biconnected_components.cpp", "biconnected_components.java", "README.md"], "code/graph-algorithms/Bipartite_check": ["Bipartite_check.java"], "code/graph-algorithms/bipartite_checking": ["bipartite.cpp", "bipartite_checking.cpp", "BipartiteBfs.java", "bipartitecheckingusing_bfs.cpp", "BipartiteGraphCheckAdjacencyList.java", "README.md"], "code/graph-algorithms/boruvka_minimum_spanning_tree": ["boruvka_minimum_spanning_tree.cpp", "README.md"], "code/graph-algorithms/breadth_first_search": ["bfs.c", "bfs.cpp", "Bfs.java", "bfs.rb", "breadth_first_search.py", "breadth_first_search.swift", "README.md"], "code/graph-algorithms/bridge_tree": ["bridge_tree.cpp"], "code/graph-algorithms/bridges_in_graph": ["bridges.cpp", "README.md"], "code/graph-algorithms/bron_kerbosch_algorithm": ["bron_kerbosch.java"], "code/graph-algorithms/centroid_decomposition": ["centroid_decomposition.java"], "code/graph-algorithms/channel_assignment": ["README.md"], "code/graph-algorithms/count_of_ways_n": ["Count_of_ways_n.cpp"], "code/graph-algorithms/cut_vertices": ["cut_vertices.cpp", "README.md"], "code/graph-algorithms/cycle_directed_graph": ["cycle_directed_graph.cpp", "cycle_directed_graph.py", "README.md"], "code/graph-algorithms/cycle_undirected_graph": ["CheckCycle.java", "cycle_undirected_graph.py", "cycle_using_union_find_datastructure.cpp", "cycleGraph.cpp", "README.md"], "code/graph-algorithms/depth_first_search": ["depth_first_search.py", "dfs.c", "dfs.cpp", "dfs.go", "Dfs.java", "Dfs.kt", "dfs.rb", "README.md"], "code/graph-algorithms/dijkstra_shortest_path": ["dijkstra.cpp", "Dijkstra.py", "Dijkstra_Algorithm.c", "dijkstra_efficient.py", "dijkstra_gnu_fast.cpp", "README.md"], "code/graph-algorithms/dinic_maximum_flow": ["dinic_maximum_flow.cpp"], "code/graph-algorithms/eulerian_path": ["eulerian.java", "eulerian.py", "README.md"], "code/graph-algorithms/fleury_algorithm_euler_path": ["README.md"], "code/graph-algorithms/floyd_warshall_algorithm": ["floyd_warshall.cpp", "floyd_warshall.py", "floydWarshall.c", "FloydWarshall.java", "README.md"], "code/graph-algorithms/ford_fulkerson_maximum_flow": ["ford_fulkerson.cpp", "ford_fulkerson_using_bfs.cpp", "ford_fulkerson_using_bfs.py", "FordFulkersonUsingBfs.java", "README.md"], "code/graph-algorithms/graph_coloring": ["graph_color_greedy.py", "graph_coloring.cpp", "graph_coloring.java", "README.md"], "code/graph-algorithms/hamiltonian_cycle": ["hamiltonian_cycle.py", "README.md"], "code/graph-algorithms/hamiltonian_path": ["hamiltonian_path.cpp"], "code/graph-algorithms/hopcroft_karp_algorithm": ["README.md"], "code/graph-algorithms/johnson_algorithm_shortest_path": ["johnsons_algo.py", "README.md"], "code/graph-algorithms/karger_minimum_cut": ["karger.java", "README.md"], "code/graph-algorithms/kruskal_minimum_spanning_tree": ["kruskal_minimum_spanning_tree.cpp", "kruskal_minimum_spanning_tree.py", "kruskal_mst.c", "Kruskals.java", "README.md"], "code/graph-algorithms/kuhn_maximum_matching": ["kuhn_maximum_matching.cpp"], "code/graph-algorithms/left_view_binary_tree": ["left_view_binary.py", "left_view_binary_tree.cpp"], "code/graph-algorithms/longest_path_directed_acyclic_graph": ["longest_path_directed_acyclic_graph.cpp", "README.md"], "code/graph-algorithms/maximum_bipartite_matching": ["max_bipartite_matching.py", "README.md"], "code/graph-algorithms/maximum_edge_disjoint_paths": ["README.md"], "code/graph-algorithms/minimum_s_t_cut": ["README.md"], "code/graph-algorithms/postorder_from_inorder_and_preorder": ["inprepost.cpp"], "code/graph-algorithms/prim_minimum_spanning_tree": ["prim_minimum_spanning_tree.cpp", "prim_minimum_spanning_tree.py", "Prims.c", "README.md"], "code/graph-algorithms/shortest_path_k_edges": ["README.md"], "code/graph-algorithms/steiner_tree": ["steiner_tree.java"], "code/graph-algorithms/strongly_connected_components": ["README.md", "strongly_connected_components.cpp", "strongly_connected_components.py"], "code/graph-algorithms/tarjan_algorithm_strongly_connected_components": ["README.md"], "code/graph-algorithms/topological_sort": ["kahn_algo_unique_toposort.cpp", "README.md", "topological.hs", "TopologicalSortAdjacencyList.java", "TopologicalSortAdjacencyMatrix.java", "toposort.cpp", "toposort.py"], "code/graph-algorithms/transitive_closure_graph": ["README.md", "transitive_closure.cpp", "transitive_closure_graph.py", "transitive_closure_graph_floyd_warshall.cpp"], "code/graph-algorithms/travelling_salesman_mst": ["README.md", "Travelling_salesman.cpp", "travelling_salesman.py"], "code/graph-algorithms/vertex_cover": ["README.md"], "code/greedy-algorithms/activity_selection": ["activity_selection.cpp", "activity_selection.java", "activity_selection.py", "README.md"], "code/greedy-algorithms/dijkstra_shortest_path": ["dijkstra-shortest-path.cpp", "dijkstra_shortest_path.c", "dijkstra_shortest_path.java", "dijkstra_shortest_path.py", "README.md"], "code/greedy-algorithms/egyptian_fraction": ["egyptian_fraction.cpp", "egyptian_fraction.py"], "code/greedy-algorithms/fractional_knapsack": ["fractional_knapsack.c", "fractional_knapsack.cpp", "fractional_knapsack.cs", "fractional_knapsack.go", "fractional_knapsack.java", "fractional_knapsack.py", "README.md"], "code/greedy-algorithms/hillclimber": ["Hillclimber.java"], "code/greedy-algorithms/huffman_coding": ["huffman_codiing.py", "huffman_coding.cpp", "README.md"], "code/greedy-algorithms/job_sequencing": ["job_sequencing.cpp", "job_sequencing.py", "README.md"], "code/greedy-algorithms/k_centers": ["k_centers.py", "README.md"], "code/greedy-algorithms/kruskal_minimum_spanning_tree": ["kruskal.c", "kruskal.py", "README.md"], "code/greedy-algorithms/minimum_coins": ["minimum-coins.js", "minimum_coins.cpp", "minimum_coins.go", "minimum_coins.py", "MinimumCoins.hs", "MinimumCoins.java", "README.md"], "code/greedy-algorithms/prim_minimum_spanning_tree": ["prim_mst.cpp", "prim_mst_haskell.hs", "prims_mst.py", "README.md"], "code/greedy-algorithms/warshall": ["warshalls.c"], "code/mathematical-algorithms/2Sum": ["2sum.c", "2sum.cpp", "2sum.go", "2sum.java", "2sum.js", "2sum.py", "2sum.rb", "2sum.rs"], "code/mathematical-algorithms/add_polynomial": ["add_poly.c", "add_polynomials.cpp", "add_polynomials.go", "README.md"], "code/mathematical-algorithms/amicable_numbers": ["amicable numbers.py", "amicable.go", "amicable_numbers.cpp", "amicable_numbers.cs", "amicable_numbers.java", "amicable_numbers.js", "amicable_numbers.py", "amicable_numbers.rb", "amicable_numbers.rs"], "code/mathematical-algorithms/armstrong_numbers": ["armstrong.go", "armstrong.py", "armstrong.rb", "armstrong_numbers.c", "armstrong_numbers.cpp", "armstrong_numbers.cs", "armstrong_numbers.java", "armstrong_numbers.js", "README.md"], "code/mathematical-algorithms/automorphic_numbers": ["automorphic.cpp", "automorphic.cs", "automorphic.go", "automorphic.hs", "automorphic.js", "automorphic.php", "automorphic.py", "automorphic.rb", "automorphic.swift", "automorphic_numbers.c", "AutomorphicNumber.java", "README.md"], "code/mathematical-algorithms/average_stream_numbers": ["average_stream_numbers.cpp", "average_stream_numbers.go", "average_stream_numbers.py", "README.md"], "code/mathematical-algorithms/babylonian_method": ["babylonian.c", "Babylonian.java", "babylonian_method.cpp", "babylonian_method.go", "Babylonian_method.py", "babylonian_root.cpp", "babylonian_sqrt.js", "README.md"], "code/mathematical-algorithms/basic/Greatest_digit_in_number": ["greatest-digit-in-number.js", "Greatest_digit_in_number.c", "Greatest_digit_in_number.cpp", "greatest_digit_in_number.cs", "Greatest_digit_in_number.hs", "Greatest_digit_in_number.java", "greatest_digit_in_number.php", "greatest_digit_in_number.py", "greatest_digit_in_number.rb"], "code/mathematical-algorithms/basic/log_of_factorial": ["logfactorial.c", "logfactorial.cpp", "logfactorial.py"], "code/mathematical-algorithms/basic/Smallest_digit_in_number": ["smallest_digit_in_number.c", "smallest_digit_in_number.cpp", "Smallest_digit_in_number.hs", "smallest_digit_in_number.java", "smallest_digit_in_number.js", "smallest_digit_in_number.php", "smallest_digit_in_number.py", "smallest_digit_in_number.rb"], "code/mathematical-algorithms/binomial_coefficient": ["binomial_coefficient_modular.cpp", "binomialCoefficient.cpp", "binomialCoefficient.go", "BinomialCoefficient.java", "BinomialCoefficient.py", "README.md"], "code/mathematical-algorithms/catalan_number": ["Catalan.scala", "catalan_number.c", "catalan_number.js", "catalan_number.py", "catalan_number.rb", "catalan_number_dynamic.cpp", "catalan_number_recursive.cpp", "CatalanNumber.java", "catlan_number.py", "README.md"], "code/mathematical-algorithms/Check_is_square": ["check_is_square.cs", "check_is_square.go", "check_is_square.php", "check_is_square.rs", "check_is_square.swift", "Finding_Square.py", "FindingISquare.cpp", "FindingISquare_binary_search.cpp", "FindingSquare.java", "FindingSquare.scala", "perfect_square.ruby", "perfectSquare.js"], "code/mathematical-algorithms/classic_number_problems/taxicab_numbers": ["taxicab_numbers.py"], "code/mathematical-algorithms/convertToRoman": ["convertToRoman.js", "index.js"], "code/mathematical-algorithms/convolution": ["convolution.cpp"], "code/mathematical-algorithms/coprime_numbers": ["coprime.go", "Coprime_numbers.c", "coprime_numbers.cpp", "coprime_numbers.cs", "coprime_numbers.go", "coprime_numbers.js", "coprime_numbers.py", "coprime_numbers.rs", "coprime_recursion.cpp"], "code/mathematical-algorithms/count_digits": ["count_digits.c", "count_digits.cpp", "count_digits.cs", "count_digits.go", "count_digits.hs", "Count_digits.java", "count_digits.js", "count_digits.py", "count_digits.swift"], "code/mathematical-algorithms/count_trailing_zeroes": ["count_trailing_zeroes.c", "Count_trailing_zeroes.scala", "count_trailing_zeroes_factorial.java", "count_trailing_zeros_factorial.cpp", "count_trailing_zeros_factorial.js", "count_trailing_zeros_factorial.py"], "code/mathematical-algorithms/decoding_of_string": ["README.md"], "code/mathematical-algorithms/delannoy_number": ["delannoy_number.cpp", "README.md"], "code/mathematical-algorithms/dfa_division": ["README.md"], "code/mathematical-algorithms/diophantine": ["diophantine.cpp"], "code/mathematical-algorithms/divided_differences": ["divided_differences.java", "README.md"], "code/mathematical-algorithms/EulerTotient": ["euler_totient.c", "euler_totient.cpp", "euler_totient.py", "euler_totient_sieve.cpp", "euler_totient_sieve.py", "EulerTotient.java", "makefile", "Readme.md"], "code/mathematical-algorithms/exponentiation_power/exponentiation_by_squaring": ["exponentiation_by_squaring.cpp", "exponentiation_by_squaring.go", "exponentiation_by_squaring.py"], "code/mathematical-algorithms/factorial": ["factorial-hrw.py", "factorial.c", "factorial.clj", "factorial.erl", "factorial.ex", "factorial.go", "factorial.hs", "Factorial.java", "factorial.php", "factorial.rb", "factorial.rs", "factorial.scala", "factorial.swift", "factorial_iteration.c", "factorial_iteration.cs", "factorial_iteration.js", "factorial_iteration.py", "factorial_recursion.c", "factorial_recursion.cpp", "factorial_recursion.cs", "factorial_recursion.js", "factorial_recursion.py"], "code/mathematical-algorithms/fast_fourier_transform": ["FFT.java"], "code/mathematical-algorithms/fast_inverse_sqrt": ["fast_inverse_sqrt.cpp"], "code/mathematical-algorithms/fermats_little_theorem": ["fermat_little.cpp", "fermats_little.py"], "code/mathematical-algorithms/fibonacci_number": ["fast_fibo.c", "fibonacci.c", "fibonacci.clj", "fibonacci.cpp", "fibonacci.cs", "fibonacci.erl", "fibonacci.ex", "fibonacci.go", "fibonacci.hs", "fibonacci.java", "fibonacci.js", "fibonacci.php", "fibonacci.py", "fibonacci.rb", "fibonacci.rs", "fibonacci.scala", "fibonacci.swift", "fibonacci_for_big_numbers.cpp", "fibonacci_matrix_exponentiation.cpp", "fibonacci_matrix_multiplication.py", "fibonacci_memorized.swift", "README.md"], "code/mathematical-algorithms/fractals": ["julia-miim.cpp", "simple-julia.cpp"], "code/mathematical-algorithms/gaussian_elimination": ["gaussian_elimination.cpp", "gaussian_elimination.java"], "code/mathematical-algorithms/gcd_and_lcm": ["gcd-and-lcm.js", "gcd_and_lcm.c", "gcd_and_lcm.cs", "gcd_and_lcm.erl", "gcd_and_lcm.ex", "gcd_and_lcm.go", "gcd_and_lcm.php", "gcd_and_lcm.py", "gcd_and_lcm.scala", "gcd_gnu.cpp", "Gcd_Lcm_Calc.java", "gcdandlcm.cpp"], "code/mathematical-algorithms/hill_climbing": ["hill_climbing.java"], "code/mathematical-algorithms/horner_polynomial_evaluation": ["horner.cpp", "Horner.java", "README.md"], "code/mathematical-algorithms/integer_conversion": ["decimal_to_any_base.js", "decimal_to_any_base.py", "decimal_to_bin.cpp", "decimal_to_hex.cpp", "decimal_to_int.go", "decimal_to_oct.cpp"], "code/mathematical-algorithms/IntegerToRoman": ["integerToRoman.js"], "code/mathematical-algorithms/karatsuba_multiplication": ["karatsuba_multiplication.java"], "code/mathematical-algorithms/largrange_polynomial": ["lagrange_polynomial.java", "README.md"], "code/mathematical-algorithms/lexicographic_string_rank": ["lexicographic_string_rank.c", "lexicographic_string_rank.cpp", "lexicographic_string_rank.java", "lexicographic_string_rank.py", "README.md"], "code/mathematical-algorithms/lucas_theorem": ["LucasTheorem.cpp"], "code/mathematical-algorithms/lucky_number": ["lucky_number.c", "lucky_number.java", "README.md"], "code/mathematical-algorithms/magic_square": ["magic_square.py", "README.md"], "code/mathematical-algorithms/modular_inverse": ["modular_inverse.cpp", "modular_inverse.java", "modular_inverse.py", "modular_inverse.rb"], "code/mathematical-algorithms/multiply_polynomial": ["FFT.cpp", "README.md"], "code/mathematical-algorithms/newton_polynomial": ["newton_polynomial.java", "README.md"], "code/mathematical-algorithms/newton_raphson_method": ["newton_raphson.c", "newton_raphson.cpp", "newton_raphson.php", "README.md"], "code/mathematical-algorithms/next_larger_number": ["next_larger_number.cpp", "next_larger_number.java", "next_larger_number.php", "next_larger_number.py"], "code/mathematical-algorithms/pandigital_number": ["pandigital_number.c", "pandigital_number.rb", "README.md"], "code/mathematical-algorithms/pascal_triangle": ["pascal_triangle.cpp", "pascal_triangle.exs", "pascal_triangle.go", "pascal_triangle.java", "pascal_triangle.py", "README.md"], "code/mathematical-algorithms/perfect_number": [".gitignore", "perfect_number.c", "perfect_number.cpp", "perfect_number.hs", "perfect_number.java", "perfect_number.js", "perfect_number.php", "perfect_number.py", "perfect_number.rb", "perfect_number.rs", "perfect_number_list.cpp", "README.md"], "code/mathematical-algorithms/permutation_lexicographic_order": ["permutation_lexicographic_order.cpp", "README.md"], "code/mathematical-algorithms/poisson_sample": ["poisson_sample.py"], "code/mathematical-algorithms/primality_tests/fermat_primality_test": ["fermat_primality_test.c"], "code/mathematical-algorithms/primality_tests/miller_rabin_primality_test": ["miller_rabin_primality_test.cpp", "miller_rabin_primality_test.py"], "code/mathematical-algorithms/primality_tests/solovay-strassen_primality_test": ["solovay_strassen.cpp"], "code/mathematical-algorithms/prime_factors": ["prime_factors.cpp", "prime_factors.go", "prime_factors.java", "prime_factors.py", "SummationOfPrime.cpp"], "code/mathematical-algorithms/prime_numbers_of_n": ["prime_factors.py", "prime_numbers_by_sieve.cpp", "README.md"], "code/mathematical-algorithms/pythagorean_triplet": ["special_pythagorean_triplet.cpp"], "code/mathematical-algorithms/replace_0_with_5": ["change0to5.py", "replace.c", "replace.cpp", "replace.java", "replace_0_with_5.js", "zero_to_five.go", "zero_to_five_efficent.cpp"], "code/mathematical-algorithms/reverse_factorial": ["reverse_factorial.go", "reverse_factorial.java", "reverse_factorial.js", "reverse_factorial.py"], "code/mathematical-algorithms/reverse_number": ["Reverse.cs", "reverse.go", "Reverse.java", "reverse_number.cpp", "reverse_number.hs", "reverse_number.js", "reverse_number.php", "reverse_number.py", "reverse_number.rb", "reverse_using_recursion.java", "reversed_number.swift"], "code/mathematical-algorithms/russian_peasant_multiplication": ["README.md", "russian_peasant.cpp", "russian_peasant.cs", "russian_peasant.js", "russian_peasant.php", "russian_peasant.py", "russian_peasant.rs", "russianPeasant.go"], "code/mathematical-algorithms/segmented_sieve_of_eratosthenes": ["segmented_sieve_of_eratosthenes.cpp"], "code/mathematical-algorithms/shuffle_array": ["arrayshuffle.rb", "README.md", "shuffle_array.cpp", "shuffle_array.js"], "code/mathematical-algorithms/sieve_of_atkin": ["sieve_of_atkin.c", "sieve_of_atkin.java", "sieve_of_atkin.py", "sieveOfAtkind.cpp"], "code/mathematical-algorithms/sieve_of_eratosthenes": ["erathosthenes.java", "erato.py", "eratosthenes.hs", "README.md", "sieve.go", "sieve_of_erathosthenes_compact.cpp", "sieve_of_eratosthenes.c", "sieve_of_eratosthenes.cpp", "sieve_of_eratosthenes.cs", "sieve_of_eratosthenes.js", "sieve_of_eratosthenes.php", "sieve_of_eratosthenes_linear.cpp"], "code/mathematical-algorithms/simpsons_rule": ["simp_rule.py"], "code/mathematical-algorithms/std": ["std.c", "std.cpp", "std.go", "std.js", "std.py"], "code/mathematical-algorithms/steepest_descent": ["steepest_descent.cpp"], "code/mathematical-algorithms/sum_of_digits": ["sum_of_digits.ex", "sum_of_digits.go", "sum_of_digits.js", "sum_of_digits.php", "sum_of_digits.rb", "sum_of_digits.rs", "sum_of_digits.swift", "sum_of_digits_function.c", "Sum_of_digits_function.cpp", "Sum_of_digits_function.py", "sum_of_digits_with_recursion.c", "sumofdigits.c", "SumOfDigits.cs", "SumOfDigits.java"], "code/mathematical-algorithms/tower_of_hanoi": ["README.md", "tower-of-hanoi.c", "tower-of-hanoi.cpp", "tower-of-hanoi.py", "tower_of_hanoi.cpp", "tower_of_hanoi.go", "tower_of_hanoi.hs", "tower_of_hanoi.js", "tower_of_hanoi.ml", "tower_of_hanoi.rs", "tower_of_hanoi_BinarySolution.c", "TowerOfHanoi.scala", "TowersOfHanoi.java"], "code/mathematical-algorithms/tribonacci_numbers": ["tribonacci.go", "Tribonacci.java", "tribonacci.rs", "tribonacci_number.cpp", "tribonacci_numbers.cpp", "Tribonacci_numbers.py", "Tribonnaci.java"], "code/networking/determine_endianess": ["determine_endianess.c"], "code/networking/validate_IP": ["ipv4_check.go", "is_valid_ip.php", "README.md", "Validate_connection_ipv4.py", "validate_ip.c", "validate_ip.rb", "validate_ip.sh", "validate_ipv4.js", "validate_ipv4.py"], "code/operating_system/bankers_algorithm": ["banker_safety.cpp"], "code/operating_system/dining_philosophers": ["dining_philosophers.c", "README.md"], "code/operating_system/first_come_first_serve": ["fcfs.cpp", "fcfs.cs", "FCFS.java", "fcfs.py", "fcfs.rs"], "code/operating_system/least_recently_used": ["lru.c"], "code/operating_system/multi_level_feedback_queue_scheduling": ["mlfq.ts"], "code/operating_system/peterson_algorithm_for_mutual_exclusion": ["mythreads.h", "peterson_algo_mutual_exclusion_in_c.c"], "code/operating_system/producer_consumer": ["producer_consumer.cpp"], "code/operating_system/readers_writes": ["readers_writes.cpp"], "code/operating_system/round_robin_scheduling": ["round_robin_scheduling.cpp", "round_robin_scheduling.java"], "code/operating_system/shortest_seek_time_first": ["shortest_seek_time_first.c", "shortest_seek_time_first.cpp"], "code/operating_system/smallest_remaining_time_first": ["srtf.c"], "code/randomized-algorithms/karger_minimum_cut_algorithm": ["karger_minimum_cut_algorithm.cpp", "README.md"], "code/randomized-algorithms/kth_smallest_element_algorithm": ["kth_smallest_element_algorithm.cpp", "README.md"], "code/randomized-algorithms/random_from_stream": ["Random_number_selection_from_a_stream.cpp"], "code/randomized-algorithms/random_node_linkedlist": ["README.md"], "code/randomized-algorithms/randomized_quick_sort": ["randomized_quicksort.c"], "code/randomized-algorithms/reservoir_sampling": ["README.md", "reservoir_sampling.cpp", "reservoir_sampling.rs"], "code/randomized-algorithms/shuffle_an_array": ["README.md", "shuffle_an_array.cpp", "Shuffle_An_Array.java", "shuffle_an_array.php", "shuffle_an_array.py", "shuffle_an_array.rb", "shuffle_an_array.rs", "shuffle_library.rb", "shuffleArray.js"], "code/search/binary_search": ["binary_search.c", "binary_search.cpp", "binary_search.cs", "binary_search.go", "binary_search.hs", "binary_search.java", "binary_search.js", "binary_search.kt", "binary_search.php", "binary_search.py", "binary_search.rb", "binary_search.rkt", "binary_search.rs", "binary_search.scala", "binary_search.sh", "binary_search.swift", "README.md"], "code/search/exponential_search": ["exponential_search.cpp", "exponential_search.go", "exponential_search.java", "exponential_search.js", "exponential_search.php", "exponential_search.rb", "exponential_search.rs", "exponential_search2.cpp", "exponential_search2.py", "README.md"], "code/search/fuzzy_search": ["fuzzy_search.js", "fuzzy_search.php"], "code/search/interpolation_search": ["interpolation_search.c", "Interpolation_search.cpp", "interpolation_search.go", "interpolation_search.java", "interpolation_search.php", "interpolation_search.py", "README.md"], "code/search/jump_search": ["jump_search.c", "jump_search.cpp", "jump_search.go", "jump_search.java", "jump_search.js", "jump_search.php", "jump_search.py", "jump_search.rs", "jump_search.swift", "README.md"], "code/search/linear_search": ["linear_search.c", "linear_search.cpp", "linear_search.cs", "linear_search.go", "linear_search.hs", "linear_search.java", "linear_search.js", "linear_search.kt", "linear_search.ml", "linear_search.nim", "linear_search.php", "linear_search.py", "linear_search.rb", "linear_search.rs", "linear_search.scala", "linear_search.swift", "README.md"], "code/search/ternary_search": ["README.md", "ternary_search.c", "ternary_search.cpp", "ternary_search.go", "Ternary_search.java", "ternary_search.js", "ternary_search.kt", "ternary_search.php", "ternary_search.py", "ternary_search.rs"], "code/selection-algorithms/median-of-medians": ["median_of_medians.c", "median_of_medians.hs", "median_of_medians.py"], "code/sorting/bead_sort": ["bead_sort.c", "bead_sort.cpp", "bead_sort.cs", "bead_sort.java", "bead_sort.js", "bead_sort.m", "bead_sort.php", "bead_sort.py", "bead_sort.swift", "beadsort_numpy.py", "README.md"], "code/sorting/bogo_sort": ["bogo_sort.cpp", "bogo_sort.fs", "bogo_sort.go", "bogo_sort.java", "bogo_sort.js", "bogo_sort.m", "bogo_sort.py", "bogo_sort.rb", "bogo_sort.swift", "README.md"], "code/sorting/bubble_sort": ["bubble_sort.c", "bubble_sort.cpp", "bubble_sort.cs", "bubble_sort.elm", "bubble_sort.exs", "Bubble_sort.f", "bubble_sort.go", "bubble_sort.hs", "bubble_sort.java", "bubble_sort.jl", "bubble_sort.js", "bubble_sort.kt", "bubble_sort.m", "bubble_sort.php", "bubble_sort.py", "bubble_sort.rb", "bubble_sort.rs", "bubble_sort.sh", "bubble_sort.sml", "bubble_sort.swift", "bubble_sort.ts", "efficientbubblesort.cpp", "README.md"], "code/sorting/bucket_sort": ["bucket_sort.c", "bucket_sort.cpp", "bucket_sort.cs", "bucket_sort.go", "bucket_sort.hs", "bucket_sort.java", "bucket_sort.js", "bucket_sort.m", "bucket_sort.php", "bucket_sort.py", "bucket_sort.rb", "bucket_sort.swift", "README.md"], "code/sorting/circle_sort": ["circle_sort.c", "circle_sort.cpp", "circle_sort.cs", "circle_sort.java", "circle_sort.js", "circle_sort.m", "circle_sort.py", "circle_sort.swift"], "code/sorting/comb_sort": ["comb_sort.cpp", "comb_sort.go", "comb_sort.java", "comb_sort.js", "comb_sort.m", "comb_sort.swift", "README.md"], "code/sorting/counting_sort": ["counting_sort.c", "counting_sort.cpp", "counting_sort.cs", "counting_sort.go", "counting_sort.java", "counting_sort.js", "counting_sort.m", "counting_sort.py", "counting_sort.swift", "README.md"], "code/sorting/cycle_sort": ["cycle_sort.cpp", "cycle_sort.cs", "cycle_sort.go", "cycle_sort.java", "cycle_sort.js", "cycle_sort.m", "cycle_sort.py", "cycle_sort.swift", "README.md"], "code/sorting/flash_sort": ["flash_sort.c", "flash_sort.js", "flash_sort.m", "flash_sort.swift", "README.md"], "code/sorting/gnome_sort": ["gnome_sort.cpp", "gnome_sort.java", "gnome_sort.m", "gnome_sort.py", "gnome_sort.swift"], "code/sorting/heap_sort": ["heap_sort.c", "heap_sort.cpp", "heap_sort.cs", "heap_sort.go", "heap_sort.java", "heap_sort.js", "heap_sort.m", "heap_sort.py", "heap_sort.rb", "heap_sort.rs", "heap_sort.sc", "heap_sort.swift", "README.md"], "code/sorting/insertion_sort": ["insertion_sort.c", "insertion_sort.cpp", "insertion_sort.cs", "insertion_sort.go", "insertion_sort.hs", "insertion_sort.java", "insertion_sort.js", "insertion_sort.m", "insertion_sort.ml", "insertion_sort.php", "insertion_sort.py", "insertion_sort.rb", "insertion_sort.rs", "insertion_sort.sh", "insertion_sort.swift", "README.md"], "code/sorting/intro_sort": ["intro_sort.cpp", "intro_sort.m", "intro_sort.swift"], "code/sorting/median_sort": ["median_sort.cpp", "median_sort.cs", "median_sort.m", "median_sort.py", "median_sort.swift", "median_sort_fast.cpp"], "code/sorting/merge_sort": ["merge_sort.c", "merge_sort.cpp", "merge_sort.cs", "merge_sort.fs", "merge_sort.go", "merge_sort.hs", "merge_sort.java", "merge_sort.js", "merge_sort.m", "merge_sort.php", "merge_sort.pl", "merge_sort.py", "merge_sort.rb", "merge_sort.rs", "merge_sort.scala", "merge_sort.swift", "merge_sort.ts", "mergesort_linkedlist.c", "README.md"], "code/sorting/pigeonhole_sort": ["pigeonhole_sort.c", "pigeonhole_sort.cpp", "pigeonhole_sort.cs", "pigeonhole_sort.java", "pigeonhole_sort.m", "pigeonhole_sort.py", "pigeonhole_sort.swift", "README.md"], "code/sorting/quick_sort": ["dutch_national_flag.cpp", "quick_sort.c", "quick_sort.cpp", "quick_sort.cs", "quick_sort.elm", "quick_sort.go", "quick_sort.hs", "quick_sort.java", "quick_sort.js", "quick_sort.lua", "quick_sort.m", "quick_sort.ml", "quick_sort.py", "quick_sort.rb", "quick_sort.rs", "quick_sort.scala", "quick_sort.sh", "quick_sort.swift", "quick_sort.ts", "QuickSort_Median_of_Medians.c", "QuicksortInPlace.scala", "README.md", "threeWay_quick_sort.cpp"], "code/sorting/radix_sort": ["radix_sort.c", "radix_sort.cpp", "radix_sort.go", "radix_sort.hs", "radix_sort.java", "radix_sort.py", "radix_sort.rs", "README.md"], "code/sorting/selection_sort": ["README.md", "selection_sort.c", "selection_sort.cpp", "selection_sort.cs", "selection_sort.go", "selection_sort.hs", "selection_sort.java", "selection_sort.js", "selection_sort.kt", "selection_sort.m", "selection_sort.php", "selection_sort.py", "selection_sort.rb", "selection_sort.rs", "selection_sort.sh", "selection_sort.swift", "selection_sort.vb"], "code/sorting/shaker_sort": ["README.md", "shaker_sort.c", "shaker_sort.cpp", "shaker_sort.cs", "shaker_sort.go", "shaker_sort.java", "shaker_sort.js", "shaker_sort.m", "shaker_sort.php", "shaker_sort.py", "shaker_sort.rs", "shaker_sort.swift"], "code/sorting/shell_sort": ["README.md", "shell_sort.c", "shell_sort.cpp", "shell_sort.go", "shell_sort.java", "shell_sort.js", "shell_sort.m", "shell_sort.py", "shell_sort.swift"], "code/sorting/sleep_sort": ["README.md", "sleep_sort.c", "sleep_sort.cpp", "sleep_sort.cs", "sleep_sort.go", "sleep_sort.java", "sleep_sort.jl", "sleep_sort.js", "sleep_sort.m", "sleep_sort.php", "sleep_sort.py", "sleep_sort.rb", "sleep_sort.scala", "sleep_sort.sh", "sleep_sort.swift"], "code/sorting/stooge_sort": ["README.md", "stooge_sort.c", "stooge_sort.go", "stooge_sort.java", "stooge_sort.js", "stooge_sort.py"], "code/sorting/topological_sort": ["topological_sort.c", "topological_sort.cpp", "topological_sort.java"], "code/sorting/tree_sort": ["tree_sort.c", "tree_sort.cpp", "tree_sort.go", "tree_sort.java", "tree_sort.js", "tree_sort.py"], "code/square_root_decomposition/MO's Algorithm": ["MOAlgo.cpp"], "code/string-algorithms/aho_corasick_algorithm": ["aho_corasick.cpp", "aho_corasick.java", "aho_corasick_algorithm.cpp", "README.md"], "code/string-algorithms/anagram_search": ["anagram_search.c", "anagram_search.cpp", "anagram_search.cs", "anagram_search.go", "anagram_search.java", "anagram_search.js", "anagram_search.py", "anagram_search.rb", "anagram_search.swift", "README.md"], "code/string-algorithms/arithmetic_on_large_numbers": ["string_addition.cpp", "string_factorial.cpp", "string_multiplication.cpp", "string_subtract.cpp"], "code/string-algorithms/boyer_moore_algorithm": ["boyer_moore.c", "boyer_moore_algorithm.cpp", "README.md"], "code/string-algorithms/finite_automata": ["README.md", "SearchStringUsingDFA.java", "SearchStringUsingDFA.rs"], "code/string-algorithms/kasai_algorithm": ["README.md"], "code/string-algorithms/kmp_algorithm": ["kmp.py", "kmp_algorithm.cpp", "README.md"], "code/string-algorithms/levenshtein_distance": ["LevenshteinDistance.java"], "code/string-algorithms/lipogram_checker": ["lipogram_checker.cpp", "lipogram_checker.js", "lipogram_checker.py"], "code/string-algorithms/manachar_algorithm": ["manachar_longest_palindromic_subs.cpp", "manachar_longest_palindromic_subs.py"], "code/string-algorithms/morse-code": ["morsecode.go", "morsecode.py"], "code/string-algorithms/naive_pattern_search": ["naive_pattern_search.py", "README.md"], "code/string-algorithms/palindrome_checker": ["palindrome.c", "palindrome.clj", "palindrome.cpp", "palindrome.cs", "palindrome.erl", "palindrome.ex", "palindrome.go", "palindrome.hs", "Palindrome.java", "palindrome.js", "Palindrome.kt", "palindrome.lua", "palindrome.php", "Palindrome.purs", "palindrome.py", "palindrome.rb", "palindrome.rs", "palindrome.sh", "palindrome.swift"], "code/string-algorithms/pangram_checker": ["pangram-checker.js", "pangram.cpp", "Pangram.java", "pangram.rb", "pangram_checker.c", "pangram_checker.go", "pangram_checker.m", "pangram_checker.py", "pangram_checker.swift"], "code/string-algorithms/password_strength_checker": ["pw_checker.cpp", "pw_checker.java", "pw_checker.js", "pw_checker.py", "README.md"], "code/string-algorithms/rabin_karp_algorithm": ["rabin-karp.c", "rabin_karp.py", "RabinKarp.java", "README.md"], "code/string-algorithms/suffix_array": ["README.md", "suffixArray.java"], "code/string-algorithms/trie_pattern_search": ["README.md", "trie.cpp"], "code/string-algorithms/z_algorithm": ["README.md", "Z-algo.cpp", "Z_Algorithm.py", "z_algorithm_z_array.cpp"], "code/unclassified/average": ["average.c", "average.cpp", "average.erl", "average.es6.js", "average.ex", "average.go", "average.java", "average.js", "average.php", "average.py", "average.rb", "average.rs", "average.scala", "average.swift"], "code/unclassified/biggest_Of_N_Numbers": ["biggest_Of_N_Numbers.c"], "code/unclassified/biggest_suffix": ["biggest_suffix.c"], "code/unclassified/fifteen_puzzle": ["fifteen.c", "log.txt", "Makefile", "readme.md"], "code/unclassified/jaccard-similarity": ["jaccard.c", "jaccard.java", "jaccard.py", "README.md"], "code/unclassified/josephus_problem": ["josephus.c", "josephus.cpp", "josephus.go", "josephus.py"], "code/unclassified/magic_square": ["magic_square.c", "magic_square.php", "magic_square.py", "magic_square.swift"], "code/unclassified/majority_element": ["majority_element.cpp"], "code/unclassified/minimum_subarray_size_with_degree": ["minSubarraySizeWithDegree.cpp"], "code/unclassified/paint_fill": ["paint_fill.cpp"], "code/unclassified/spiral_printing": ["spiral.c", "spiral_print.cpp", "spiral_print.go", "spiral_print_array.py"], "code/unclassified/split_list": ["split_list.py"], "code/unclassified/tokenizer": ["string_tokenizer.cpp"], "code/unclassified/utilities": ["convert2mp3.sh", "download_link.sh"]}